From 1ed796fe4c9a125f301e2b322c952412513e4d7b Mon Sep 17 00:00:00 2001 From: Andrey Prokopenko Date: Wed, 30 Jan 2019 15:57:46 -0500 Subject: [PATCH 01/40] Update to the latest SWIG --- src/belos/src/forbelos.f90 | 199 +- src/belos/src/forbelosFORTRAN_wrap.cxx | 56 +- src/interface/src/fortrilinos.f90 | 283 +- src/interface/src/fortrilinosFORTRAN_wrap.cxx | 274 +- src/interface/src/nox.i | 36 +- src/teuchos/src/forteuchos.f90 | 338 +- src/teuchos/src/forteuchos.i | 2 +- src/teuchos/src/forteuchosFORTRAN_wrap.cxx | 188 +- src/teuchos/test/test_teuchos_comm.f90 | 4 +- src/teuchos/test/test_teuchos_plist.f90 | 8 +- src/tpetra/src/Tpetra_Map.i | 2 +- src/tpetra/src/Tpetra_Operator.i | 20 +- src/tpetra/src/fortpetra.f90 | 2501 ++++++++----- src/tpetra/src/fortpetra.i | 6 +- src/tpetra/src/fortpetraFORTRAN_wrap.cxx | 3208 +++++++++-------- src/utils/src/forerror.f90 | 31 +- src/utils/src/forerrorFORTRAN_wrap.cxx | 17 +- swig_hash | 1 + 18 files changed, 4089 insertions(+), 3085 deletions(-) create mode 100644 swig_hash diff --git a/src/belos/src/forbelos.f90 b/src/belos/src/forbelos.f90 index d2dfa8c5..3bc6ae64 100644 --- a/src/belos/src/forbelos.f90 +++ b/src/belos/src/forbelos.f90 @@ -15,98 +15,84 @@ module forbelos implicit none private - ! PUBLIC METHODS AND TYPES - public :: BelosETrans, BelosNOTRANS, BelosTRANS, BelosCONJTRANS - public :: BelosNormType, BelosOneNorm, BelosTwoNorm, BelosInfNorm - public :: BelosScaleType, BelosNormOfRHS, BelosNormOfInitRes, BelosNormOfPrecInitRes, BelosNone, BelosUserProvided, & - BelosNormOfFullInitRes, BelosNormOfFullPrecInitRes, BelosNormOfFullScaledInitRes, BelosNormOfFullScaledPrecInitRes - public :: BelosOutputType, BelosGeneral, BelosBrief, BelosUser - public :: BelosReturnType, BelosConverged, BelosUnconverged - -type, bind(C) :: SwigArrayWrapper - type(C_PTR), public :: data = C_NULL_PTR - integer(C_SIZE_T), public :: size = 0 -end type - - public :: convertReturnTypeToString - public :: convertStatusTypeToString - public :: convertStringToStatusType - public :: convertStringToScaleType - public :: convertScaleTypeToString - public :: BelosConjType, BelosNO_CONJ, BelosCONJ - public :: convertMsgTypeToString - public :: DefaultSolverParameters - - enum, bind(c) - enumerator :: SwigMemState = -1 - enumerator :: SWIG_NULL = 0 - enumerator :: SWIG_OWN - enumerator :: SWIG_MOVE - enumerator :: SWIG_REF - enumerator :: SWIG_CREF - end enum - - -type, bind(C) :: SwigClassWrapper - type(C_PTR), public :: ptr = C_NULL_PTR - integer(C_INT), public :: mem = SWIG_NULL -end type - - - ! PARAMETERS + ! DECLARATION CONSTRUCTS + ! enum Belos::ETrans enum, bind(c) - enumerator :: BelosETrans = -1 enumerator :: BelosNOTRANS = 0 enumerator :: BelosTRANS = 1 enumerator :: BelosCONJTRANS = 2 end enum + integer, parameter, public :: BelosETrans = kind(BelosNOTRANS) + public :: BelosNOTRANS, BelosTRANS, BelosCONJTRANS + ! enum Belos::NormType enum, bind(c) - enumerator :: BelosNormType = -1 - enumerator :: BelosOneNorm = 0 - enumerator :: BelosTwoNorm = BelosOneNorm + 1 - enumerator :: BelosInfNorm = BelosTwoNorm + 1 + enumerator :: BelosOneNorm + enumerator :: BelosTwoNorm + enumerator :: BelosInfNorm end enum + integer, parameter, public :: BelosNormType = kind(BelosOneNorm) + public :: BelosOneNorm, BelosTwoNorm, BelosInfNorm + ! enum Belos::ScaleType enum, bind(c) - enumerator :: BelosScaleType = -1 - enumerator :: BelosNormOfRHS = 0 - enumerator :: BelosNormOfInitRes = BelosNormOfRHS + 1 - enumerator :: BelosNormOfPrecInitRes = BelosNormOfInitRes + 1 - enumerator :: BelosNone = BelosNormOfPrecInitRes + 1 - enumerator :: BelosUserProvided = BelosNone + 1 - enumerator :: BelosNormOfFullInitRes = BelosUserProvided + 1 - enumerator :: BelosNormOfFullPrecInitRes = BelosNormOfFullInitRes + 1 - enumerator :: BelosNormOfFullScaledInitRes = BelosNormOfFullPrecInitRes + 1 - enumerator :: BelosNormOfFullScaledPrecInitRes = BelosNormOfFullScaledInitRes + 1 + enumerator :: BelosNormOfRHS + enumerator :: BelosNormOfInitRes + enumerator :: BelosNormOfPrecInitRes + enumerator :: BelosNone + enumerator :: BelosUserProvided + enumerator :: BelosNormOfFullInitRes + enumerator :: BelosNormOfFullPrecInitRes + enumerator :: BelosNormOfFullScaledInitRes + enumerator :: BelosNormOfFullScaledPrecInitRes end enum + integer, parameter, public :: BelosScaleType = kind(BelosNormOfRHS) + public :: BelosNormOfRHS, BelosNormOfInitRes, BelosNormOfPrecInitRes, BelosNone, BelosUserProvided, BelosNormOfFullInitRes, & + BelosNormOfFullPrecInitRes, BelosNormOfFullScaledInitRes, BelosNormOfFullScaledPrecInitRes + ! enum Belos::OutputType enum, bind(c) - enumerator :: BelosOutputType = -1 - enumerator :: BelosGeneral = 0 - enumerator :: BelosBrief = BelosGeneral + 1 - enumerator :: BelosUser = BelosBrief + 1 + enumerator :: BelosGeneral + enumerator :: BelosBrief + enumerator :: BelosUser end enum + integer, parameter, public :: BelosOutputType = kind(BelosGeneral) + public :: BelosGeneral, BelosBrief, BelosUser + ! enum Belos::ReturnType enum, bind(c) - enumerator :: BelosReturnType = -1 - enumerator :: BelosConverged = 0 - enumerator :: BelosUnconverged = BelosConverged + 1 + enumerator :: BelosConverged + enumerator :: BelosUnconverged end enum - integer(C_INT), parameter, public :: BelosStatusType = -1_C_INT + integer, parameter, public :: BelosReturnType = kind(BelosConverged) + public :: BelosConverged, BelosUnconverged + type, bind(C) :: SwigArrayWrapper + type(C_PTR), public :: data = C_NULL_PTR + integer(C_SIZE_T), public :: size = 0 + end type + public :: convertReturnTypeToString + ! enum Belos::StatusType integer(C_INT), protected, public, & bind(C, name="_wrap_BelosPassed") :: BelosPassed integer(C_INT), protected, public, & bind(C, name="_wrap_BelosFailed") :: BelosFailed integer(C_INT), protected, public, & bind(C, name="_wrap_BelosUndefined") :: BelosUndefined - integer(C_INT), parameter, public :: BelosResetType = -1_C_INT + integer, parameter, public :: BelosStatusType = C_INT + ! enum Belos::ResetType integer(C_INT), protected, public, & bind(C, name="_wrap_BelosProblem") :: BelosProblem integer(C_INT), protected, public, & bind(C, name="_wrap_BelosRecycleSubspace") :: BelosRecycleSubspace + integer, parameter, public :: BelosResetType = C_INT + public :: convertStatusTypeToString + public :: convertStringToStatusType + public :: convertStringToScaleType + public :: convertScaleTypeToString + ! enum Belos::ConjType enum, bind(c) - enumerator :: BelosConjType = -1 - enumerator :: BelosNO_CONJ = 0 - enumerator :: BelosCONJ = BelosNO_CONJ + 1 + enumerator :: BelosNO_CONJ + enumerator :: BelosCONJ end enum - integer(C_INT), parameter, public :: BelosMsgType = -1_C_INT + integer, parameter, public :: BelosConjType = kind(BelosNO_CONJ) + public :: BelosNO_CONJ, BelosCONJ + ! enum Belos::MsgType integer(C_INT), protected, public, & bind(C, name="_wrap_BelosErrors") :: BelosErrors integer(C_INT), protected, public, & @@ -123,6 +109,20 @@ module forbelos bind(C, name="_wrap_BelosStatusTestDetails") :: BelosStatusTestDetails integer(C_INT), protected, public, & bind(C, name="_wrap_BelosDebug") :: BelosDebug + integer, parameter, public :: BelosMsgType = C_INT + public :: convertMsgTypeToString + enum, bind(c) + enumerator :: SWIG_NULL + enumerator :: SWIG_OWN + enumerator :: SWIG_MOVE + enumerator :: SWIG_REF + enumerator :: SWIG_CREF + end enum + integer, parameter :: SwigMemState = kind(SWIG_NULL) + type, bind(C) :: SwigClassWrapper + type(C_PTR), public :: cptr = C_NULL_PTR + integer(C_INT), public :: mem = SWIG_NULL + end type real(C_DOUBLE), protected, public, & bind(C, name="_wrap_DefaultSolverParameters_convTol") :: DefaultSolverParameters_convTol real(C_DOUBLE), protected, public, & @@ -133,10 +133,8 @@ module forbelos bind(C, name="_wrap_DefaultSolverParameters_resScaleFactor") :: DefaultSolverParameters_resScaleFactor real(C_DOUBLE), protected, public, & bind(C, name="_wrap_DefaultSolverParameters_impTolScale") :: DefaultSolverParameters_impTolScale - - ! TYPES - type :: DefaultSolverParameters - ! These should be treated as PROTECTED data + ! struct Belos::DefaultSolverParameters + type, public :: DefaultSolverParameters type(SwigClassWrapper), public :: swigdata contains procedure :: release => delete_DefaultSolverParameters @@ -144,33 +142,30 @@ module forbelos generic :: assignment(=) => swigf_assignment_DefaultSolverParameters end type DefaultSolverParameters interface DefaultSolverParameters - procedure new_DefaultSolverParameters + module procedure new_DefaultSolverParameters end interface - - ! WRAPPER DECLARATIONS - interface +! WRAPPER DECLARATIONS +interface function swigc_convertReturnTypeToString(farg1) & bind(C, name="_wrap_convertReturnTypeToString") & result(fresult) use, intrinsic :: ISO_C_BINDING -import :: SwigArrayWrapper +import :: swigarraywrapper integer(C_INT), intent(in) :: farg1 type(SwigArrayWrapper) :: fresult end function - -subroutine SWIG_free(ptr) & + subroutine SWIG_free(cptr) & bind(C, name="free") use, intrinsic :: ISO_C_BINDING - type(C_PTR), value :: ptr + type(C_PTR), value :: cptr end subroutine - function swigc_convertStatusTypeToString(farg1) & bind(C, name="_wrap_convertStatusTypeToString") & result(fresult) use, intrinsic :: ISO_C_BINDING -import :: SwigArrayWrapper +import :: swigarraywrapper integer(C_INT), intent(in) :: farg1 type(SwigArrayWrapper) :: fresult end function @@ -179,7 +174,7 @@ function swigc_convertStringToStatusType(farg1) & bind(C, name="_wrap_convertStringToStatusType") & result(fresult) use, intrinsic :: ISO_C_BINDING -import :: SwigArrayWrapper +import :: swigarraywrapper type(SwigArrayWrapper) :: farg1 integer(C_INT) :: fresult end function @@ -188,7 +183,7 @@ function swigc_convertStringToScaleType(farg1) & bind(C, name="_wrap_convertStringToScaleType") & result(fresult) use, intrinsic :: ISO_C_BINDING -import :: SwigArrayWrapper +import :: swigarraywrapper type(SwigArrayWrapper) :: farg1 integer(C_INT) :: fresult end function @@ -197,7 +192,7 @@ function swigc_convertScaleTypeToString(farg1) & bind(C, name="_wrap_convertScaleTypeToString") & result(fresult) use, intrinsic :: ISO_C_BINDING -import :: SwigArrayWrapper +import :: swigarraywrapper integer(C_INT), intent(in) :: farg1 type(SwigArrayWrapper) :: fresult end function @@ -206,7 +201,7 @@ function swigc_convertMsgTypeToString(farg1) & bind(C, name="_wrap_convertMsgTypeToString") & result(fresult) use, intrinsic :: ISO_C_BINDING -import :: SwigArrayWrapper +import :: swigarraywrapper integer(C_INT), intent(in) :: farg1 type(SwigArrayWrapper) :: fresult end function @@ -215,14 +210,14 @@ function swigc_new_DefaultSolverParameters() & bind(C, name="_wrap_new_DefaultSolverParameters") & result(fresult) use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: fresult end function subroutine swigc_delete_DefaultSolverParameters(farg1) & bind(C, name="_wrap_delete_DefaultSolverParameters") use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 end subroutine @@ -233,11 +228,11 @@ subroutine swigc_assignment_DefaultSolverParameters(self, other) & type(SwigClassWrapper), intent(inout) :: self type(SwigClassWrapper), intent(in) :: other end subroutine - end interface +end interface contains - ! FORTRAN PROXY CODE + ! MODULE SUBPROGRAMS subroutine SWIG_chararray_to_string(wrap, string) use, intrinsic :: ISO_C_BINDING @@ -256,7 +251,8 @@ function convertReturnTypeToString(result) & result(swig_result) use, intrinsic :: ISO_C_BINDING character(kind=C_CHAR, len=:), allocatable :: swig_result -integer(kind(BelosReturnType)), intent(in) :: result +integer(BelosReturnType), intent(in) :: result + type(SwigArrayWrapper) :: fresult integer(C_INT) :: farg1 @@ -270,7 +266,8 @@ function convertStatusTypeToString(status) & result(swig_result) use, intrinsic :: ISO_C_BINDING character(kind=C_CHAR, len=:), allocatable :: swig_result -integer(kind(BelosStatusType)), intent(in) :: status +integer(BelosStatusType), intent(in) :: status + type(SwigArrayWrapper) :: fresult integer(C_INT) :: farg1 @@ -301,9 +298,10 @@ subroutine SWIG_string_to_chararray(string, chars, wrap) function convertStringToStatusType(status) & result(swig_result) use, intrinsic :: ISO_C_BINDING -integer(kind(BelosStatusType)) :: swig_result +integer(BelosStatusType) :: swig_result character(kind=C_CHAR, len=*), target :: status character(kind=C_CHAR), dimension(:), allocatable, target :: farg1_chars + integer(C_INT) :: fresult type(SwigArrayWrapper) :: farg1 @@ -315,9 +313,10 @@ function convertStringToStatusType(status) & function convertStringToScaleType(scaletype) & result(swig_result) use, intrinsic :: ISO_C_BINDING -integer(kind(BelosScaleType)) :: swig_result +integer(BelosScaleType) :: swig_result character(kind=C_CHAR, len=*), target :: scaletype character(kind=C_CHAR), dimension(:), allocatable, target :: farg1_chars + integer(C_INT) :: fresult type(SwigArrayWrapper) :: farg1 @@ -330,7 +329,8 @@ function convertScaleTypeToString(scaletype) & result(swig_result) use, intrinsic :: ISO_C_BINDING character(kind=C_CHAR, len=:), allocatable :: swig_result -integer(kind(BelosScaleType)), intent(in) :: scaletype +integer(BelosScaleType), intent(in) :: scaletype + type(SwigArrayWrapper) :: fresult integer(C_INT) :: farg1 @@ -344,7 +344,8 @@ function convertMsgTypeToString(msgtype) & result(swig_result) use, intrinsic :: ISO_C_BINDING character(kind=C_CHAR, len=:), allocatable :: swig_result -integer(kind(BelosMsgType)), intent(in) :: msgtype +integer(BelosMsgType), intent(in) :: msgtype + type(SwigArrayWrapper) :: fresult integer(C_INT) :: farg1 @@ -358,7 +359,8 @@ function new_DefaultSolverParameters() & result(self) use, intrinsic :: ISO_C_BINDING type(DefaultSolverParameters) :: self -type(SwigClassWrapper) :: fresult + +type(SwigClassWrapper) :: fresult fresult = swigc_new_DefaultSolverParameters() self%swigdata = fresult @@ -367,13 +369,14 @@ function new_DefaultSolverParameters() & subroutine delete_DefaultSolverParameters(self) use, intrinsic :: ISO_C_BINDING class(DefaultSolverParameters), intent(inout) :: self -type(SwigClassWrapper) :: farg1 + +type(SwigClassWrapper) :: farg1 farg1 = self%swigdata if (self%swigdata%mem == SWIG_OWN) then call swigc_delete_DefaultSolverParameters(farg1) end if -self%swigdata%ptr = C_NULL_PTR +self%swigdata%cptr = C_NULL_PTR self%swigdata%mem = SWIG_NULL end subroutine diff --git a/src/belos/src/forbelosFORTRAN_wrap.cxx b/src/belos/src/forbelosFORTRAN_wrap.cxx index eab57051..30e22fc4 100644 --- a/src/belos/src/forbelosFORTRAN_wrap.cxx +++ b/src/belos/src/forbelosFORTRAN_wrap.cxx @@ -191,7 +191,7 @@ template T SwigValueInit() { #define SWIG_exception_impl(DECL, CODE, MSG, RETURNNULL) \ - { throw std::logic_error("In " DECL ": " MSG); RETURNNULL; } + { throw std::logic_error("In " DECL ": " MSG); } extern "C" { @@ -301,7 +301,7 @@ SWIGINTERN SwigArrayWrapper SwigArrayWrapper_uninitialized() { enum SwigMemState { - SWIG_NULL = 0, + SWIG_NULL, SWIG_OWN, SWIG_MOVE, SWIG_REF, @@ -310,14 +310,14 @@ enum SwigMemState { struct SwigClassWrapper { - void* ptr; + void* cptr; SwigMemState mem; }; SWIGINTERN SwigClassWrapper SwigClassWrapper_uninitialized() { SwigClassWrapper result; - result.ptr = NULL; + result.cptr = NULL; result.mem = SWIG_NULL; return result; } @@ -460,27 +460,28 @@ struct AssignmentTraits { template SWIGINTERN void SWIG_assign_impl(SwigClassWrapper* self, SwigClassWrapper* other) { typedef swig::AssignmentTraits Traits_t; - T1* pself = static_cast(self->ptr); - T2* pother = static_cast(other->ptr); + T1* pself = static_cast(self->cptr); + T2* pother = static_cast(other->cptr); switch (self->mem) { case SWIG_NULL: /* LHS is unassigned */ switch (other->mem) { - case SWIG_NULL: /* null op */ break; + case SWIG_NULL: /* null op */ + break; case SWIG_MOVE: /* capture pointer from RHS */ - self->ptr = other->ptr; - other->ptr = NULL; + self->cptr = other->cptr; + other->cptr = NULL; self->mem = SWIG_OWN; other->mem = SWIG_NULL; break; case SWIG_OWN: /* copy from RHS */ - self->ptr = Traits_t::copy_construct(pother); + self->cptr = Traits_t::copy_construct(pother); self->mem = SWIG_OWN; break; case SWIG_REF: /* pointer to RHS */ case SWIG_CREF: - self->ptr = other->ptr; + self->cptr = other->cptr; self->mem = other->mem; break; } @@ -491,14 +492,14 @@ SWIGINTERN void SWIG_assign_impl(SwigClassWrapper* self, SwigClassWrapper* other case SWIG_NULL: /* Delete LHS */ Traits_t::destruct(pself); - self->ptr = NULL; + self->cptr = NULL; self->mem = SWIG_NULL; break; case SWIG_MOVE: /* Move RHS into LHS; delete RHS */ Traits_t::move_assign(pself, pother); Traits_t::destruct(pother); - other->ptr = NULL; + other->cptr = NULL; other->mem = SWIG_NULL; break; case SWIG_OWN: @@ -519,7 +520,7 @@ SWIGINTERN void SWIG_assign_impl(SwigClassWrapper* self, SwigClassWrapper* other switch (other->mem) { case SWIG_NULL: /* Remove LHS reference */ - self->ptr = NULL; + self->cptr = NULL; self->mem = SWIG_NULL; break; case SWIG_MOVE: @@ -527,7 +528,7 @@ SWIGINTERN void SWIG_assign_impl(SwigClassWrapper* self, SwigClassWrapper* other * same. */ Traits_t::move_assign(pself, pother); Traits_t::destruct(pother); - other->ptr = NULL; + other->cptr = NULL; other->mem = SWIG_NULL; break; case SWIG_OWN: @@ -542,8 +543,9 @@ SWIGINTERN void SWIG_assign_impl(SwigClassWrapper* self, SwigClassWrapper* other switch (other->mem) { case SWIG_NULL: /* Remove LHS reference */ - self->ptr = NULL; + self->cptr = NULL; self->mem = SWIG_NULL; + break; default: SWIG_exception_impl("assignment", SWIG_RuntimeError, "Cannot assign to a const reference", return); @@ -682,22 +684,22 @@ SWIGEXPORT SwigArrayWrapper _wrap_convertMsgTypeToString(int const *farg1) { } -SWIGEXPORT SWIGEXTERN double const _wrap_DefaultSolverParameters_convTol = Belos::DefaultSolverParameters::convTol; +SWIGEXPORT SWIGEXTERN double const _wrap_DefaultSolverParameters_convTol = static_cast< double >(Belos::DefaultSolverParameters::convTol); -SWIGEXPORT SWIGEXTERN double const _wrap_DefaultSolverParameters_polyTol = Belos::DefaultSolverParameters::polyTol; +SWIGEXPORT SWIGEXTERN double const _wrap_DefaultSolverParameters_polyTol = static_cast< double >(Belos::DefaultSolverParameters::polyTol); -SWIGEXPORT SWIGEXTERN double const _wrap_DefaultSolverParameters_orthoKappa = Belos::DefaultSolverParameters::orthoKappa; +SWIGEXPORT SWIGEXTERN double const _wrap_DefaultSolverParameters_orthoKappa = static_cast< double >(Belos::DefaultSolverParameters::orthoKappa); -SWIGEXPORT SWIGEXTERN double const _wrap_DefaultSolverParameters_resScaleFactor = Belos::DefaultSolverParameters::resScaleFactor; +SWIGEXPORT SWIGEXTERN double const _wrap_DefaultSolverParameters_resScaleFactor = static_cast< double >(Belos::DefaultSolverParameters::resScaleFactor); -SWIGEXPORT SWIGEXTERN double const _wrap_DefaultSolverParameters_impTolScale = Belos::DefaultSolverParameters::impTolScale; +SWIGEXPORT SWIGEXTERN double const _wrap_DefaultSolverParameters_impTolScale = static_cast< double >(Belos::DefaultSolverParameters::impTolScale); SWIGEXPORT SwigClassWrapper _wrap_new_DefaultSolverParameters() { SwigClassWrapper fresult ; Belos::DefaultSolverParameters *result = 0 ; - + result = (Belos::DefaultSolverParameters *)new Belos::DefaultSolverParameters(); - fresult.ptr = result; + fresult.cptr = result; fresult.mem = (1 ? SWIG_MOVE : SWIG_REF); return fresult; } @@ -705,16 +707,16 @@ SWIGEXPORT SwigClassWrapper _wrap_new_DefaultSolverParameters() { SWIGEXPORT void _wrap_delete_DefaultSolverParameters(SwigClassWrapper const *farg1) { Belos::DefaultSolverParameters *arg1 = (Belos::DefaultSolverParameters *) 0 ; - + SWIG_check_mutable_nonnull(*farg1, "Belos::DefaultSolverParameters *", "DefaultSolverParameters", "Belos::DefaultSolverParameters::~DefaultSolverParameters()", return ); - arg1 = static_cast< Belos::DefaultSolverParameters * >(farg1->ptr); + arg1 = static_cast< Belos::DefaultSolverParameters * >(farg1->cptr); delete arg1; - + } SWIGEXPORT void _wrap_assign_DefaultSolverParameters(SwigClassWrapper * self, SwigClassWrapper const * other) { - typedef ::Belos::DefaultSolverParameters swig_lhs_classtype; + typedef Belos::DefaultSolverParameters swig_lhs_classtype; SWIG_assign(swig_lhs_classtype, self, swig_lhs_classtype, const_cast(other), 0 | swig::IS_DESTR | swig::IS_COPY_CONSTR); diff --git a/src/interface/src/fortrilinos.f90 b/src/interface/src/fortrilinos.f90 index 0343dc1c..750455d5 100644 --- a/src/interface/src/fortrilinos.f90 +++ b/src/interface/src/fortrilinos.f90 @@ -17,58 +17,21 @@ module fortrilinos implicit none private - ! PUBLIC METHODS AND TYPES - public :: TrilinosSolver - + ! DECLARATION CONSTRUCTS enum, bind(c) - enumerator :: SwigMemState = -1 - enumerator :: SWIG_NULL = 0 + enumerator :: SWIG_NULL enumerator :: SWIG_OWN enumerator :: SWIG_MOVE enumerator :: SWIG_REF enumerator :: SWIG_CREF end enum - - -type, bind(C) :: SwigClassWrapper - type(C_PTR), public :: ptr = C_NULL_PTR + integer, parameter :: SwigMemState = kind(SWIG_NULL) + type, bind(C) :: SwigClassWrapper + type(C_PTR), public :: cptr = C_NULL_PTR integer(C_INT), public :: mem = SWIG_NULL -end type - - public :: TrilinosEigenSolver - -type, bind(C) :: SwigArrayWrapper - type(C_PTR), public :: data = C_NULL_PTR - integer(C_SIZE_T), public :: size = 0 -end type - - public :: ForTrilinosModelEvaluator - public :: ForModelEvaluator - -public :: init_ForModelEvaluator - - public :: NOXSolver - public :: NOXStatusType, NOXUnevaluated, NOXUnconverged, NOXConverged, NOXFailed - public :: NOXCheckType, NOXComplete, NOXMinimal, NOXNone - - ! PARAMETERS - enum, bind(c) - enumerator :: NOXStatusType = -1 - enumerator :: NOXUnevaluated = -2 - enumerator :: NOXUnconverged = 0 - enumerator :: NOXConverged = 1 - enumerator :: NOXFailed = -1 - end enum - enum, bind(c) - enumerator :: NOXCheckType = -1 - enumerator :: NOXComplete = 0 - enumerator :: NOXMinimal = NOXComplete + 1 - enumerator :: NOXNone = NOXMinimal + 1 - end enum - - ! TYPES - type :: TrilinosSolver - ! These should be treated as PROTECTED data + end type + ! class ForTrilinos::TrilinosSolver + type, public :: TrilinosSolver type(SwigClassWrapper), public :: swigdata contains procedure, private :: init__SWIG_0 => swigf_TrilinosSolver_init__SWIG_0 @@ -84,10 +47,14 @@ module fortrilinos generic :: assignment(=) => swigf_assignment_TrilinosSolver end type TrilinosSolver interface TrilinosSolver - procedure new_TrilinosSolver + module procedure new_TrilinosSolver end interface - type :: TrilinosEigenSolver - ! These should be treated as PROTECTED data + type, bind(C) :: SwigArrayWrapper + type(C_PTR), public :: data = C_NULL_PTR + integer(C_SIZE_T), public :: size = 0 + end type + ! class ForTrilinos::TrilinosEigenSolver + type, public :: TrilinosEigenSolver type(SwigClassWrapper), public :: swigdata contains procedure, private :: init__SWIG_0 => swigf_TrilinosEigenSolver_init__SWIG_0 @@ -105,10 +72,10 @@ module fortrilinos generic :: assignment(=) => swigf_assignment_TrilinosEigenSolver end type TrilinosEigenSolver interface TrilinosEigenSolver - procedure new_TrilinosEigenSolver + module procedure new_TrilinosEigenSolver end interface - type :: ForTrilinosModelEvaluator - ! These should be treated as PROTECTED data + ! class ForTrilinos::ModelEvaluator< SC,LO,GO,NO > + type, public :: ForTrilinosModelEvaluator type(SwigClassWrapper), public :: swigdata contains procedure :: evaluate_residual => swigf_ForTrilinosModelEvaluator_evaluate_residual @@ -122,7 +89,8 @@ module fortrilinos procedure, private :: swigf_assignment_ForTrilinosModelEvaluator generic :: assignment(=) => swigf_assignment_ForTrilinosModelEvaluator end type ForTrilinosModelEvaluator - type, extends(ForTrilinosModelEvaluator) :: ForModelEvaluator + ! class ForModelEvaluator + type, extends(ForTrilinosModelEvaluator), public :: ForModelEvaluator contains procedure :: fhandle => swigf_ForModelEvaluator_fhandle procedure :: init => swigf_ForModelEvaluator_init @@ -138,15 +106,19 @@ module fortrilinos generic :: assignment(=) => swigf_assignment_ForModelEvaluator end type ForModelEvaluator interface ForModelEvaluator - procedure new_ForModelEvaluator + module procedure new_ForModelEvaluator end interface type :: ForModelEvaluatorHandle class(ForModelEvaluator), pointer :: data end type - type :: NOXSolver - ! These should be treated as PROTECTED data + +public :: init_ForModelEvaluator + +integer, parameter, public :: SWIGTYPE_NOX__StatusTest__StatusType = C_INT + ! class ForTrilinos::NOXSolver< SC,LO,GO,NO > + type, public :: NOXSolver type(SwigClassWrapper), public :: swigdata contains procedure :: setup => swigf_NOXSolver_setup @@ -156,31 +128,47 @@ module fortrilinos generic :: assignment(=) => swigf_assignment_NOXSolver end type NOXSolver interface NOXSolver - procedure new_NOXSolver + module procedure new_NOXSolver end interface + ! enum NOX::StatusTest::StatusType + enum, bind(c) + enumerator :: NOXUnevaluated = -2 + enumerator :: NOXUnconverged = 0 + enumerator :: NOXConverged = 1 + enumerator :: NOXFailed = -1 + end enum + integer, parameter, public :: NOXStatusType = kind(NOXUnevaluated) + public :: NOXUnevaluated, NOXUnconverged, NOXConverged, NOXFailed + ! enum NOX::StatusTest::CheckType + enum, bind(c) + enumerator :: NOXComplete + enumerator :: NOXMinimal + enumerator :: NOXNone + end enum + integer, parameter, public :: NOXCheckType = kind(NOXComplete) + public :: NOXComplete, NOXMinimal, NOXNone - - ! WRAPPER DECLARATIONS - interface +! WRAPPER DECLARATIONS +interface function swigc_new_TrilinosSolver() & bind(C, name="_wrap_new_TrilinosSolver") & result(fresult) use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: fresult end function subroutine swigc_TrilinosSolver_init__SWIG_0(farg1) & bind(C, name="_wrap_TrilinosSolver_init__SWIG_0") use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 end subroutine subroutine swigc_TrilinosSolver_init__SWIG_1(farg1, farg2) & bind(C, name="_wrap_TrilinosSolver_init__SWIG_1") use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 end subroutine @@ -188,7 +176,7 @@ subroutine swigc_TrilinosSolver_init__SWIG_1(farg1, farg2) & subroutine swigc_TrilinosSolver_setup_matrix(farg1, farg2) & bind(C, name="_wrap_TrilinosSolver_setup_matrix") use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 end subroutine @@ -196,7 +184,7 @@ subroutine swigc_TrilinosSolver_setup_matrix(farg1, farg2) & subroutine swigc_TrilinosSolver_setup_operator(farg1, farg2) & bind(C, name="_wrap_TrilinosSolver_setup_operator") use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 end subroutine @@ -204,7 +192,7 @@ subroutine swigc_TrilinosSolver_setup_operator(farg1, farg2) & subroutine swigc_TrilinosSolver_setup_solver(farg1, farg2) & bind(C, name="_wrap_TrilinosSolver_setup_solver") use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 end subroutine @@ -212,7 +200,7 @@ subroutine swigc_TrilinosSolver_setup_solver(farg1, farg2) & subroutine swigc_TrilinosSolver_solve(farg1, farg2, farg3) & bind(C, name="_wrap_TrilinosSolver_solve") use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 type(SwigClassWrapper) :: farg3 @@ -221,14 +209,14 @@ subroutine swigc_TrilinosSolver_solve(farg1, farg2, farg3) & subroutine swigc_TrilinosSolver_finalize(farg1) & bind(C, name="_wrap_TrilinosSolver_finalize") use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 end subroutine subroutine swigc_delete_TrilinosSolver(farg1) & bind(C, name="_wrap_delete_TrilinosSolver") use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 end subroutine @@ -243,21 +231,21 @@ function swigc_new_TrilinosEigenSolver() & bind(C, name="_wrap_new_TrilinosEigenSolver") & result(fresult) use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: fresult end function subroutine swigc_TrilinosEigenSolver_init__SWIG_0(farg1) & bind(C, name="_wrap_TrilinosEigenSolver_init__SWIG_0") use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 end subroutine subroutine swigc_TrilinosEigenSolver_init__SWIG_1(farg1, farg2) & bind(C, name="_wrap_TrilinosEigenSolver_init__SWIG_1") use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 end subroutine @@ -265,7 +253,7 @@ subroutine swigc_TrilinosEigenSolver_init__SWIG_1(farg1, farg2) & subroutine swigc_TrilinosEigenSolver_setup_matrix(farg1, farg2) & bind(C, name="_wrap_TrilinosEigenSolver_setup_matrix") use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 end subroutine @@ -273,7 +261,7 @@ subroutine swigc_TrilinosEigenSolver_setup_matrix(farg1, farg2) & subroutine swigc_TrilinosEigenSolver_setup_matrix_rhs(farg1, farg2) & bind(C, name="_wrap_TrilinosEigenSolver_setup_matrix_rhs") use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 end subroutine @@ -281,7 +269,7 @@ subroutine swigc_TrilinosEigenSolver_setup_matrix_rhs(farg1, farg2) & subroutine swigc_TrilinosEigenSolver_setup_operator(farg1, farg2) & bind(C, name="_wrap_TrilinosEigenSolver_setup_operator") use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 end subroutine @@ -289,7 +277,7 @@ subroutine swigc_TrilinosEigenSolver_setup_operator(farg1, farg2) & subroutine swigc_TrilinosEigenSolver_setup_operator_rhs(farg1, farg2) & bind(C, name="_wrap_TrilinosEigenSolver_setup_operator_rhs") use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 end subroutine @@ -297,7 +285,7 @@ subroutine swigc_TrilinosEigenSolver_setup_operator_rhs(farg1, farg2) & subroutine swigc_TrilinosEigenSolver_setup_solver(farg1, farg2) & bind(C, name="_wrap_TrilinosEigenSolver_setup_solver") use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 end subroutine @@ -306,8 +294,8 @@ function swigc_TrilinosEigenSolver_solve(farg1, farg2, farg3, farg4) & bind(C, name="_wrap_TrilinosEigenSolver_solve") & result(fresult) use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper -import :: SwigArrayWrapper +import :: swigclasswrapper +import :: swigarraywrapper type(SwigClassWrapper) :: farg1 type(SwigArrayWrapper) :: farg2 type(SwigClassWrapper) :: farg3 @@ -318,14 +306,14 @@ function swigc_TrilinosEigenSolver_solve(farg1, farg2, farg3, farg4) & subroutine swigc_TrilinosEigenSolver_finalize(farg1) & bind(C, name="_wrap_TrilinosEigenSolver_finalize") use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 end subroutine subroutine swigc_delete_TrilinosEigenSolver(farg1) & bind(C, name="_wrap_delete_TrilinosEigenSolver") use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 end subroutine @@ -339,7 +327,7 @@ subroutine swigc_assignment_TrilinosEigenSolver(self, other) & subroutine swigc_ForTrilinosModelEvaluator_evaluate_residual(farg1, farg2, farg3) & bind(C, name="_wrap_ForTrilinosModelEvaluator_evaluate_residual") use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 type(SwigClassWrapper) :: farg3 @@ -348,7 +336,7 @@ subroutine swigc_ForTrilinosModelEvaluator_evaluate_residual(farg1, farg2, farg3 subroutine swigc_ForTrilinosModelEvaluator_evaluate_jacobian(farg1, farg2, farg3) & bind(C, name="_wrap_ForTrilinosModelEvaluator_evaluate_jacobian") use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 type(SwigClassWrapper) :: farg3 @@ -357,7 +345,7 @@ subroutine swigc_ForTrilinosModelEvaluator_evaluate_jacobian(farg1, farg2, farg3 subroutine swigc_ForTrilinosModelEvaluator_evaluate_preconditioner(farg1, farg2, farg3) & bind(C, name="_wrap_ForTrilinosModelEvaluator_evaluate_preconditioner") use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 type(SwigClassWrapper) :: farg3 @@ -367,7 +355,7 @@ function swigc_ForTrilinosModelEvaluator_get_x_map(farg1) & bind(C, name="_wrap_ForTrilinosModelEvaluator_get_x_map") & result(fresult) use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: fresult end function @@ -376,7 +364,7 @@ function swigc_ForTrilinosModelEvaluator_get_f_map(farg1) & bind(C, name="_wrap_ForTrilinosModelEvaluator_get_f_map") & result(fresult) use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: fresult end function @@ -385,7 +373,7 @@ function swigc_ForTrilinosModelEvaluator_create_operator(farg1) & bind(C, name="_wrap_ForTrilinosModelEvaluator_create_operator") & result(fresult) use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: fresult end function @@ -393,7 +381,7 @@ function swigc_ForTrilinosModelEvaluator_create_operator(farg1) & subroutine swigc_ForTrilinosModelEvaluator_setup(farg1, farg2) & bind(C, name="_wrap_ForTrilinosModelEvaluator_setup") use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 end subroutine @@ -401,7 +389,7 @@ subroutine swigc_ForTrilinosModelEvaluator_setup(farg1, farg2) & subroutine swigc_delete_ForTrilinosModelEvaluator(farg1) & bind(C, name="_wrap_delete_ForTrilinosModelEvaluator") use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 end subroutine @@ -416,7 +404,7 @@ function swigc_ForModelEvaluator_fhandle(farg1) & bind(C, name="_wrap_ForModelEvaluator_fhandle") & result(fresult) use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 type(C_PTR) :: fresult end function @@ -424,7 +412,7 @@ function swigc_ForModelEvaluator_fhandle(farg1) & subroutine swigc_ForModelEvaluator_init(farg1, farg2) & bind(C, name="_wrap_ForModelEvaluator_init") use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 type(C_PTR), value :: farg2 end subroutine @@ -432,7 +420,7 @@ subroutine swigc_ForModelEvaluator_init(farg1, farg2) & subroutine swigc_ForModelEvaluator_setup(farg1, farg2) & bind(C, name="_wrap_ForModelEvaluator_setup") use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 end subroutine @@ -440,7 +428,7 @@ subroutine swigc_ForModelEvaluator_setup(farg1, farg2) & subroutine swigc_ForModelEvaluator_evaluate_residual(farg1, farg2, farg3) & bind(C, name="_wrap_ForModelEvaluator_evaluate_residual") use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 type(SwigClassWrapper) :: farg3 @@ -449,7 +437,7 @@ subroutine swigc_ForModelEvaluator_evaluate_residual(farg1, farg2, farg3) & subroutine swigc_ForModelEvaluator_evaluate_jacobian(farg1, farg2, farg3) & bind(C, name="_wrap_ForModelEvaluator_evaluate_jacobian") use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 type(SwigClassWrapper) :: farg3 @@ -458,7 +446,7 @@ subroutine swigc_ForModelEvaluator_evaluate_jacobian(farg1, farg2, farg3) & subroutine swigc_ForModelEvaluator_evaluate_preconditioner(farg1, farg2, farg3) & bind(C, name="_wrap_ForModelEvaluator_evaluate_preconditioner") use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 type(SwigClassWrapper) :: farg3 @@ -468,7 +456,7 @@ function swigc_ForModelEvaluator_get_x_map(farg1) & bind(C, name="_wrap_ForModelEvaluator_get_x_map") & result(fresult) use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: fresult end function @@ -477,7 +465,7 @@ function swigc_ForModelEvaluator_get_f_map(farg1) & bind(C, name="_wrap_ForModelEvaluator_get_f_map") & result(fresult) use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: fresult end function @@ -486,7 +474,7 @@ function swigc_ForModelEvaluator_create_operator(farg1) & bind(C, name="_wrap_ForModelEvaluator_create_operator") & result(fresult) use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: fresult end function @@ -495,14 +483,14 @@ function swigc_new_ForModelEvaluator() & bind(C, name="_wrap_new_ForModelEvaluator") & result(fresult) use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: fresult end function subroutine swigc_delete_ForModelEvaluator(farg1) & bind(C, name="_wrap_delete_ForModelEvaluator") use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 end subroutine @@ -517,7 +505,7 @@ function swigc_new_NOXSolver(farg1) & bind(C, name="_wrap_new_NOXSolver") & result(fresult) use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: fresult end function @@ -525,7 +513,7 @@ function swigc_new_NOXSolver(farg1) & subroutine swigc_NOXSolver_setup(farg1, farg2) & bind(C, name="_wrap_NOXSolver_setup") use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 end subroutine @@ -534,7 +522,7 @@ function swigc_NOXSolver_solve(farg1) & bind(C, name="_wrap_NOXSolver_solve") & result(fresult) use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 integer(C_INT) :: fresult end function @@ -542,7 +530,7 @@ function swigc_NOXSolver_solve(farg1) & subroutine swigc_delete_NOXSolver(farg1) & bind(C, name="_wrap_delete_NOXSolver") use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 end subroutine @@ -553,15 +541,16 @@ subroutine swigc_assignment_NOXSolver(self, other) & type(SwigClassWrapper), intent(inout) :: self type(SwigClassWrapper), intent(in) :: other end subroutine - end interface +end interface contains - ! FORTRAN PROXY CODE + ! MODULE SUBPROGRAMS function new_TrilinosSolver() & result(self) use, intrinsic :: ISO_C_BINDING type(TrilinosSolver) :: self + type(SwigClassWrapper) :: fresult fresult = swigc_new_TrilinosSolver() @@ -571,6 +560,7 @@ function new_TrilinosSolver() & subroutine swigf_TrilinosSolver_init__SWIG_0(self) use, intrinsic :: ISO_C_BINDING class(TrilinosSolver), intent(inout) :: self + type(SwigClassWrapper) :: farg1 farg1 = self%swigdata @@ -580,7 +570,9 @@ subroutine swigf_TrilinosSolver_init__SWIG_0(self) subroutine swigf_TrilinosSolver_init__SWIG_1(self, comm) use, intrinsic :: ISO_C_BINDING class(TrilinosSolver), intent(inout) :: self + class(TeuchosComm), intent(in) :: comm + type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 @@ -592,7 +584,9 @@ subroutine swigf_TrilinosSolver_init__SWIG_1(self, comm) subroutine swigf_TrilinosSolver_setup_matrix(self, a) use, intrinsic :: ISO_C_BINDING class(TrilinosSolver), intent(inout) :: self + class(TpetraCrsMatrix), intent(in) :: a + type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 @@ -604,7 +598,9 @@ subroutine swigf_TrilinosSolver_setup_matrix(self, a) subroutine swigf_TrilinosSolver_setup_operator(self, a) use, intrinsic :: ISO_C_BINDING class(TrilinosSolver), intent(inout) :: self + class(TpetraOperator), intent(in) :: a + type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 @@ -616,7 +612,9 @@ subroutine swigf_TrilinosSolver_setup_operator(self, a) subroutine swigf_TrilinosSolver_setup_solver(self, paramlist) use, intrinsic :: ISO_C_BINDING class(TrilinosSolver), intent(inout) :: self + class(ParameterList), intent(in) :: paramlist + type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 @@ -628,8 +626,11 @@ subroutine swigf_TrilinosSolver_setup_solver(self, paramlist) subroutine swigf_TrilinosSolver_solve(self, rhs, lhs) use, intrinsic :: ISO_C_BINDING class(TrilinosSolver), intent(in) :: self + class(TpetraMultiVector), intent(in) :: rhs + class(TpetraMultiVector), intent(inout) :: lhs + type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 type(SwigClassWrapper) :: farg3 @@ -643,6 +644,7 @@ subroutine swigf_TrilinosSolver_solve(self, rhs, lhs) subroutine swigf_TrilinosSolver_finalize(self) use, intrinsic :: ISO_C_BINDING class(TrilinosSolver), intent(inout) :: self + type(SwigClassWrapper) :: farg1 farg1 = self%swigdata @@ -652,13 +654,14 @@ subroutine swigf_TrilinosSolver_finalize(self) subroutine delete_TrilinosSolver(self) use, intrinsic :: ISO_C_BINDING class(TrilinosSolver), intent(inout) :: self + type(SwigClassWrapper) :: farg1 farg1 = self%swigdata if (self%swigdata%mem == SWIG_OWN) then call swigc_delete_TrilinosSolver(farg1) end if -self%swigdata%ptr = C_NULL_PTR +self%swigdata%cptr = C_NULL_PTR self%swigdata%mem = SWIG_NULL end subroutine @@ -672,6 +675,7 @@ function new_TrilinosEigenSolver() & result(self) use, intrinsic :: ISO_C_BINDING type(TrilinosEigenSolver) :: self + type(SwigClassWrapper) :: fresult fresult = swigc_new_TrilinosEigenSolver() @@ -681,6 +685,7 @@ function new_TrilinosEigenSolver() & subroutine swigf_TrilinosEigenSolver_init__SWIG_0(self) use, intrinsic :: ISO_C_BINDING class(TrilinosEigenSolver), intent(inout) :: self + type(SwigClassWrapper) :: farg1 farg1 = self%swigdata @@ -690,7 +695,9 @@ subroutine swigf_TrilinosEigenSolver_init__SWIG_0(self) subroutine swigf_TrilinosEigenSolver_init__SWIG_1(self, comm) use, intrinsic :: ISO_C_BINDING class(TrilinosEigenSolver), intent(inout) :: self + class(TeuchosComm), intent(in) :: comm + type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 @@ -702,7 +709,9 @@ subroutine swigf_TrilinosEigenSolver_init__SWIG_1(self, comm) subroutine swigf_TrilinosEigenSolver_setup_matrix(self, a) use, intrinsic :: ISO_C_BINDING class(TrilinosEigenSolver), intent(inout) :: self + class(TpetraCrsMatrix), intent(in) :: a + type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 @@ -714,7 +723,9 @@ subroutine swigf_TrilinosEigenSolver_setup_matrix(self, a) subroutine swigf_TrilinosEigenSolver_setup_matrix_rhs(self, m) use, intrinsic :: ISO_C_BINDING class(TrilinosEigenSolver), intent(inout) :: self + class(TpetraCrsMatrix), intent(in) :: m + type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 @@ -726,7 +737,9 @@ subroutine swigf_TrilinosEigenSolver_setup_matrix_rhs(self, m) subroutine swigf_TrilinosEigenSolver_setup_operator(self, a) use, intrinsic :: ISO_C_BINDING class(TrilinosEigenSolver), intent(inout) :: self + class(TpetraOperator), intent(in) :: a + type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 @@ -738,7 +751,9 @@ subroutine swigf_TrilinosEigenSolver_setup_operator(self, a) subroutine swigf_TrilinosEigenSolver_setup_operator_rhs(self, m) use, intrinsic :: ISO_C_BINDING class(TrilinosEigenSolver), intent(inout) :: self + class(TpetraOperator), intent(in) :: m + type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 @@ -750,7 +765,9 @@ subroutine swigf_TrilinosEigenSolver_setup_operator_rhs(self, m) subroutine swigf_TrilinosEigenSolver_setup_solver(self, paramlist) use, intrinsic :: ISO_C_BINDING class(TrilinosEigenSolver), intent(inout) :: self + class(ParameterList), intent(in) :: paramlist + type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 @@ -764,11 +781,14 @@ function swigf_TrilinosEigenSolver_solve(self, eigenvalues, eigenvectors, eigeni use, intrinsic :: ISO_C_BINDING integer(C_SIZE_T) :: swig_result class(TrilinosEigenSolver), intent(in) :: self + real(C_DOUBLE), dimension(:), target :: eigenvalues real(C_DOUBLE), pointer :: farg2_view class(TpetraMultiVector), intent(inout) :: eigenvectors + integer(C_INT), dimension(:), target :: eigenindex integer(C_INT), pointer :: farg4_view + integer(C_SIZE_T) :: fresult type(SwigClassWrapper) :: farg1 type(SwigArrayWrapper) :: farg2 @@ -790,6 +810,7 @@ function swigf_TrilinosEigenSolver_solve(self, eigenvalues, eigenvectors, eigeni subroutine swigf_TrilinosEigenSolver_finalize(self) use, intrinsic :: ISO_C_BINDING class(TrilinosEigenSolver), intent(inout) :: self + type(SwigClassWrapper) :: farg1 farg1 = self%swigdata @@ -799,13 +820,14 @@ subroutine swigf_TrilinosEigenSolver_finalize(self) subroutine delete_TrilinosEigenSolver(self) use, intrinsic :: ISO_C_BINDING class(TrilinosEigenSolver), intent(inout) :: self + type(SwigClassWrapper) :: farg1 farg1 = self%swigdata if (self%swigdata%mem == SWIG_OWN) then call swigc_delete_TrilinosEigenSolver(farg1) end if -self%swigdata%ptr = C_NULL_PTR +self%swigdata%cptr = C_NULL_PTR self%swigdata%mem = SWIG_NULL end subroutine @@ -818,8 +840,11 @@ subroutine swigf_assignment_TrilinosEigenSolver(self, other) subroutine swigf_ForTrilinosModelEvaluator_evaluate_residual(self, x, f) use, intrinsic :: ISO_C_BINDING class(ForTrilinosModelEvaluator), intent(in) :: self + class(TpetraMultiVector), intent(in) :: x + class(TpetraMultiVector), intent(inout) :: f + type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 type(SwigClassWrapper) :: farg3 @@ -833,8 +858,11 @@ subroutine swigf_ForTrilinosModelEvaluator_evaluate_residual(self, x, f) subroutine swigf_ForTrilinosModelEvaluator_evaluate_jacobian(self, x, j) use, intrinsic :: ISO_C_BINDING class(ForTrilinosModelEvaluator), intent(in) :: self + class(TpetraMultiVector), intent(in) :: x + class(TpetraOperator), intent(inout) :: j + type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 type(SwigClassWrapper) :: farg3 @@ -848,8 +876,11 @@ subroutine swigf_ForTrilinosModelEvaluator_evaluate_jacobian(self, x, j) subroutine swigf_ForTrilinosModelEvaluator_evaluate_preconditioner(self, x, m) use, intrinsic :: ISO_C_BINDING class(ForTrilinosModelEvaluator), intent(in) :: self + class(TpetraMultiVector), intent(in) :: x + class(TpetraOperator), intent(inout) :: m + type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 type(SwigClassWrapper) :: farg3 @@ -865,6 +896,7 @@ function swigf_ForTrilinosModelEvaluator_get_x_map(self) & use, intrinsic :: ISO_C_BINDING type(TpetraMap) :: swig_result class(ForTrilinosModelEvaluator), intent(in) :: self + type(SwigClassWrapper) :: fresult type(SwigClassWrapper) :: farg1 @@ -878,6 +910,7 @@ function swigf_ForTrilinosModelEvaluator_get_f_map(self) & use, intrinsic :: ISO_C_BINDING type(TpetraMap) :: swig_result class(ForTrilinosModelEvaluator), intent(in) :: self + type(SwigClassWrapper) :: fresult type(SwigClassWrapper) :: farg1 @@ -891,6 +924,7 @@ function swigf_ForTrilinosModelEvaluator_create_operator(self) & use, intrinsic :: ISO_C_BINDING type(TpetraOperator) :: swig_result class(ForTrilinosModelEvaluator), intent(in) :: self + type(SwigClassWrapper) :: fresult type(SwigClassWrapper) :: farg1 @@ -902,7 +936,9 @@ function swigf_ForTrilinosModelEvaluator_create_operator(self) & subroutine swigf_ForTrilinosModelEvaluator_setup(self, plist) use, intrinsic :: ISO_C_BINDING class(ForTrilinosModelEvaluator), intent(inout) :: self + class(ParameterList), intent(inout) :: plist + type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 @@ -914,13 +950,14 @@ subroutine swigf_ForTrilinosModelEvaluator_setup(self, plist) subroutine delete_ForTrilinosModelEvaluator(self) use, intrinsic :: ISO_C_BINDING class(ForTrilinosModelEvaluator), intent(inout) :: self + type(SwigClassWrapper) :: farg1 farg1 = self%swigdata if (self%swigdata%mem == SWIG_OWN) then call swigc_delete_ForTrilinosModelEvaluator(farg1) end if -self%swigdata%ptr = C_NULL_PTR +self%swigdata%cptr = C_NULL_PTR self%swigdata%mem = SWIG_NULL end subroutine @@ -935,6 +972,7 @@ function swigf_ForModelEvaluator_fhandle(self) & use, intrinsic :: ISO_C_BINDING type(C_PTR) :: swig_result class(ForModelEvaluator), intent(in) :: self + type(C_PTR) :: fresult type(SwigClassWrapper) :: farg1 @@ -946,7 +984,9 @@ function swigf_ForModelEvaluator_fhandle(self) & subroutine swigf_ForModelEvaluator_init(self, fh) use, intrinsic :: ISO_C_BINDING class(ForModelEvaluator), intent(inout) :: self + type(C_PTR) :: fh + type(SwigClassWrapper) :: farg1 type(C_PTR) :: farg2 @@ -958,7 +998,9 @@ subroutine swigf_ForModelEvaluator_init(self, fh) subroutine swigf_ForModelEvaluator_setup(self, plist) use, intrinsic :: ISO_C_BINDING class(ForModelEvaluator), intent(inout) :: self + class(ParameterList), intent(inout) :: plist + type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 @@ -970,8 +1012,11 @@ subroutine swigf_ForModelEvaluator_setup(self, plist) subroutine swigf_ForModelEvaluator_evaluate_residual(self, x, f) use, intrinsic :: ISO_C_BINDING class(ForModelEvaluator), intent(in) :: self + class(TpetraMultiVector), intent(in) :: x + class(TpetraMultiVector), intent(inout) :: f + type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 type(SwigClassWrapper) :: farg3 @@ -985,8 +1030,11 @@ subroutine swigf_ForModelEvaluator_evaluate_residual(self, x, f) subroutine swigf_ForModelEvaluator_evaluate_jacobian(self, x, j) use, intrinsic :: ISO_C_BINDING class(ForModelEvaluator), intent(in) :: self + class(TpetraMultiVector), intent(in) :: x + class(TpetraOperator), intent(inout) :: j + type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 type(SwigClassWrapper) :: farg3 @@ -1000,8 +1048,11 @@ subroutine swigf_ForModelEvaluator_evaluate_jacobian(self, x, j) subroutine swigf_ForModelEvaluator_evaluate_preconditioner(self, x, m) use, intrinsic :: ISO_C_BINDING class(ForModelEvaluator), intent(in) :: self + class(TpetraMultiVector), intent(in) :: x + class(TpetraOperator), intent(inout) :: m + type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 type(SwigClassWrapper) :: farg3 @@ -1017,6 +1068,7 @@ function swigf_ForModelEvaluator_get_x_map(self) & use, intrinsic :: ISO_C_BINDING type(TpetraMap) :: swig_result class(ForModelEvaluator), intent(in) :: self + type(SwigClassWrapper) :: fresult type(SwigClassWrapper) :: farg1 @@ -1030,6 +1082,7 @@ function swigf_ForModelEvaluator_get_f_map(self) & use, intrinsic :: ISO_C_BINDING type(TpetraMap) :: swig_result class(ForModelEvaluator), intent(in) :: self + type(SwigClassWrapper) :: fresult type(SwigClassWrapper) :: farg1 @@ -1043,6 +1096,7 @@ function swigf_ForModelEvaluator_create_operator(self) & use, intrinsic :: ISO_C_BINDING type(TpetraOperator) :: swig_result class(ForModelEvaluator), intent(in) :: self + type(SwigClassWrapper) :: fresult type(SwigClassWrapper) :: farg1 @@ -1055,6 +1109,7 @@ function new_ForModelEvaluator() & result(self) use, intrinsic :: ISO_C_BINDING type(ForModelEvaluator) :: self + type(SwigClassWrapper) :: fresult fresult = swigc_new_ForModelEvaluator() @@ -1064,6 +1119,7 @@ function new_ForModelEvaluator() & subroutine delete_ForModelEvaluator(self) use, intrinsic :: ISO_C_BINDING class(ForModelEvaluator), intent(inout) :: self + type(SwigClassWrapper) :: farg1 @@ -1075,7 +1131,7 @@ subroutine delete_ForModelEvaluator(self) if (self%swigdata%mem == SWIG_OWN) then call swigc_delete_ForModelEvaluator(farg1) end if -self%swigdata%ptr = C_NULL_PTR +self%swigdata%cptr = C_NULL_PTR self%swigdata%mem = SWIG_NULL ! Release the allocated handle @@ -1258,6 +1314,7 @@ function new_NOXSolver(model) & use, intrinsic :: ISO_C_BINDING type(NOXSolver) :: self class(ForTrilinosModelEvaluator), intent(in) :: model + type(SwigClassWrapper) :: fresult type(SwigClassWrapper) :: farg1 @@ -1269,7 +1326,9 @@ function new_NOXSolver(model) & subroutine swigf_NOXSolver_setup(self, plist) use, intrinsic :: ISO_C_BINDING class(NOXSolver), intent(inout) :: self + class(ParameterList), intent(inout) :: plist + type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 @@ -1281,8 +1340,9 @@ subroutine swigf_NOXSolver_setup(self, plist) function swigf_NOXSolver_solve(self) & result(swig_result) use, intrinsic :: ISO_C_BINDING -integer(kind(NOXStatusType)) :: swig_result +integer(SWIGTYPE_NOX__StatusTest__StatusType) :: swig_result class(NOXSolver), intent(inout) :: self + integer(C_INT) :: fresult type(SwigClassWrapper) :: farg1 @@ -1294,13 +1354,14 @@ function swigf_NOXSolver_solve(self) & subroutine delete_NOXSolver(self) use, intrinsic :: ISO_C_BINDING class(NOXSolver), intent(inout) :: self + type(SwigClassWrapper) :: farg1 farg1 = self%swigdata if (self%swigdata%mem == SWIG_OWN) then call swigc_delete_NOXSolver(farg1) end if -self%swigdata%ptr = C_NULL_PTR +self%swigdata%cptr = C_NULL_PTR self%swigdata%mem = SWIG_NULL end subroutine diff --git a/src/interface/src/fortrilinosFORTRAN_wrap.cxx b/src/interface/src/fortrilinosFORTRAN_wrap.cxx index c242513c..53a2e2b6 100644 --- a/src/interface/src/fortrilinosFORTRAN_wrap.cxx +++ b/src/interface/src/fortrilinosFORTRAN_wrap.cxx @@ -191,7 +191,7 @@ template T SwigValueInit() { #define SWIG_exception_impl(DECL, CODE, MSG, RETURNNULL) \ - { throw std::logic_error("In " DECL ": " MSG); RETURNNULL; } + { throw std::logic_error("In " DECL ": " MSG); } extern "C" { @@ -280,7 +280,7 @@ typedef char Packet; enum SwigMemState { - SWIG_NULL = 0, + SWIG_NULL, SWIG_OWN, SWIG_MOVE, SWIG_REF, @@ -289,14 +289,14 @@ enum SwigMemState { struct SwigClassWrapper { - void* ptr; + void* cptr; SwigMemState mem; }; SWIGINTERN SwigClassWrapper SwigClassWrapper_uninitialized() { SwigClassWrapper result; - result.ptr = NULL; + result.cptr = NULL; result.mem = SWIG_NULL; return result; } @@ -439,27 +439,28 @@ struct AssignmentTraits { template SWIGINTERN void SWIG_assign_impl(SwigClassWrapper* self, SwigClassWrapper* other) { typedef swig::AssignmentTraits Traits_t; - T1* pself = static_cast(self->ptr); - T2* pother = static_cast(other->ptr); + T1* pself = static_cast(self->cptr); + T2* pother = static_cast(other->cptr); switch (self->mem) { case SWIG_NULL: /* LHS is unassigned */ switch (other->mem) { - case SWIG_NULL: /* null op */ break; + case SWIG_NULL: /* null op */ + break; case SWIG_MOVE: /* capture pointer from RHS */ - self->ptr = other->ptr; - other->ptr = NULL; + self->cptr = other->cptr; + other->cptr = NULL; self->mem = SWIG_OWN; other->mem = SWIG_NULL; break; case SWIG_OWN: /* copy from RHS */ - self->ptr = Traits_t::copy_construct(pother); + self->cptr = Traits_t::copy_construct(pother); self->mem = SWIG_OWN; break; case SWIG_REF: /* pointer to RHS */ case SWIG_CREF: - self->ptr = other->ptr; + self->cptr = other->cptr; self->mem = other->mem; break; } @@ -470,14 +471,14 @@ SWIGINTERN void SWIG_assign_impl(SwigClassWrapper* self, SwigClassWrapper* other case SWIG_NULL: /* Delete LHS */ Traits_t::destruct(pself); - self->ptr = NULL; + self->cptr = NULL; self->mem = SWIG_NULL; break; case SWIG_MOVE: /* Move RHS into LHS; delete RHS */ Traits_t::move_assign(pself, pother); Traits_t::destruct(pother); - other->ptr = NULL; + other->cptr = NULL; other->mem = SWIG_NULL; break; case SWIG_OWN: @@ -498,7 +499,7 @@ SWIGINTERN void SWIG_assign_impl(SwigClassWrapper* self, SwigClassWrapper* other switch (other->mem) { case SWIG_NULL: /* Remove LHS reference */ - self->ptr = NULL; + self->cptr = NULL; self->mem = SWIG_NULL; break; case SWIG_MOVE: @@ -506,7 +507,7 @@ SWIGINTERN void SWIG_assign_impl(SwigClassWrapper* self, SwigClassWrapper* other * same. */ Traits_t::move_assign(pself, pother); Traits_t::destruct(pother); - other->ptr = NULL; + other->cptr = NULL; other->mem = SWIG_NULL; break; case SWIG_OWN: @@ -521,8 +522,9 @@ SWIGINTERN void SWIG_assign_impl(SwigClassWrapper* self, SwigClassWrapper* other switch (other->mem) { case SWIG_NULL: /* Remove LHS reference */ - self->ptr = NULL; + self->cptr = NULL; self->mem = SWIG_NULL; + break; default: SWIG_exception_impl("assignment", SWIG_RuntimeError, "Cannot assign to a const reference", return); @@ -615,17 +617,17 @@ SwigClassWrapper swigd_ForModelEvaluator_create_operator( Teuchos::RCP tempthis( const_cast(this) SWIG_NO_NULL_DELETER_0); SwigClassWrapper self; - self.ptr = &tempthis; + self.cptr = &tempthis; self.mem = SWIG_CREF; // since this function is const /* convert x -> class wrapper */ SwigClassWrapper farg1; - farg1.ptr = const_cast*>(&x); + farg1.cptr = const_cast*>(&x); farg1.mem = SWIG_CREF; // x is const /* convert f -> class wrapper */ SwigClassWrapper farg2; - farg2.ptr = &f; + farg2.cptr = &f; farg2.mem = SWIG_REF; // f is mutable swigd_ForModelEvaluator_evaluate_residual(&self, &farg1, &farg2); @@ -637,17 +639,17 @@ SwigClassWrapper swigd_ForModelEvaluator_create_operator( Teuchos::RCP tempthis( const_cast(this) SWIG_NO_NULL_DELETER_0); SwigClassWrapper self; - self.ptr = &tempthis; + self.cptr = &tempthis; self.mem = SWIG_CREF; // since this function is const /* convert x -> class wrapper */ SwigClassWrapper farg1; - farg1.ptr = const_cast*>(&x); + farg1.cptr = const_cast*>(&x); farg1.mem = SWIG_CREF; // x is const /* convert J -> class wrapper */ SwigClassWrapper farg2; - farg2.ptr = &J; + farg2.cptr = &J; farg2.mem = SWIG_REF; // f is mutable swigd_ForModelEvaluator_evaluate_jacobian(&self, &farg1, &farg2); @@ -659,17 +661,17 @@ SwigClassWrapper swigd_ForModelEvaluator_create_operator( Teuchos::RCP tempthis( const_cast(this) SWIG_NO_NULL_DELETER_0); SwigClassWrapper self; - self.ptr = &tempthis; + self.cptr = &tempthis; self.mem = SWIG_CREF; // since this function is const /* convert x -> class wrapper */ SwigClassWrapper farg1; - farg1.ptr = const_cast*>(&x); + farg1.cptr = const_cast*>(&x); farg1.mem = SWIG_CREF; // x is const /* convert M -> class wrapper */ SwigClassWrapper farg2; - farg2.ptr = &M; + farg2.cptr = &M; farg2.mem = SWIG_REF; // f is mutable swigd_ForModelEvaluator_evaluate_preconditioner(&self, &farg1, &farg2); @@ -680,12 +682,12 @@ SwigClassWrapper swigd_ForModelEvaluator_create_operator( Teuchos::RCP tempthis( const_cast(this) SWIG_NO_NULL_DELETER_0); SwigClassWrapper self; - self.ptr = &tempthis; + self.cptr = &tempthis; self.mem = SWIG_CREF; // since this function is const SwigClassWrapper fresult = swigd_ForModelEvaluator_get_x_map(&self); - Teuchos::RCP* smartresult = static_cast< Teuchos::RCP* >(fresult.ptr); + Teuchos::RCP* smartresult = static_cast< Teuchos::RCP* >(fresult.cptr); return *smartresult; } @@ -694,12 +696,12 @@ SwigClassWrapper swigd_ForModelEvaluator_create_operator( Teuchos::RCP tempthis( const_cast(this) SWIG_NO_NULL_DELETER_0); SwigClassWrapper self; - self.ptr = &tempthis; + self.cptr = &tempthis; self.mem = SWIG_CREF; // since this function is const SwigClassWrapper fresult = swigd_ForModelEvaluator_get_f_map(&self); - Teuchos::RCP* smartresult = static_cast< Teuchos::RCP* >(fresult.ptr); + Teuchos::RCP* smartresult = static_cast< Teuchos::RCP* >(fresult.cptr); return *smartresult; } @@ -708,12 +710,12 @@ SwigClassWrapper swigd_ForModelEvaluator_create_operator( Teuchos::RCP tempthis( const_cast(this) SWIG_NO_NULL_DELETER_0); SwigClassWrapper self; - self.ptr = &tempthis; + self.cptr = &tempthis; self.mem = SWIG_CREF; // since this function is const SwigClassWrapper fresult = swigd_ForModelEvaluator_create_operator(&self); - Teuchos::RCP* smartresult = static_cast< Teuchos::RCP* >(fresult.ptr); + Teuchos::RCP* smartresult = static_cast< Teuchos::RCP* >(fresult.cptr); return *smartresult; } }; @@ -761,7 +763,7 @@ SWIGEXPORT SwigClassWrapper _wrap_new_TrilinosSolver() { SWIG_exception_impl("ForTrilinos::TrilinosSolver::TrilinosSolver()", SWIG_UnknownError, "An unknown exception occurred", return SwigClassWrapper_uninitialized()); } } - fresult.ptr = result; + fresult.cptr = result; fresult.mem = (1 ? SWIG_MOVE : SWIG_REF); return fresult; } @@ -771,7 +773,7 @@ SWIGEXPORT void _wrap_TrilinosSolver_init__SWIG_0(SwigClassWrapper const *farg1) ForTrilinos::TrilinosSolver *arg1 = (ForTrilinos::TrilinosSolver *) 0 ; SWIG_check_mutable_nonnull(*farg1, "ForTrilinos::TrilinosSolver *", "TrilinosSolver", "ForTrilinos::TrilinosSolver::init()", return ); - arg1 = static_cast< ForTrilinos::TrilinosSolver * >(farg1->ptr); + arg1 = static_cast< ForTrilinos::TrilinosSolver * >(farg1->cptr); { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("ForTrilinos::TrilinosSolver::init()");; @@ -805,8 +807,8 @@ SWIGEXPORT void _wrap_TrilinosSolver_init__SWIG_1(SwigClassWrapper const *farg1, Teuchos::RCP< Teuchos::Comm< int > const > tempnull2 ; SWIG_check_mutable_nonnull(*farg1, "ForTrilinos::TrilinosSolver *", "TrilinosSolver", "ForTrilinos::TrilinosSolver::init(Teuchos::RCP< Teuchos::Comm< int > const > const &)", return ); - arg1 = static_cast< ForTrilinos::TrilinosSolver * >(farg1->ptr); - arg2 = farg2->ptr ? static_cast< Teuchos::RCP< Teuchos::Comm< int > const > * >(farg2->ptr) : &tempnull2; + arg1 = static_cast< ForTrilinos::TrilinosSolver * >(farg1->cptr); + arg2 = farg2->cptr ? static_cast< Teuchos::RCP< Teuchos::Comm< int > const > * >(farg2->cptr) : &tempnull2; { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("ForTrilinos::TrilinosSolver::init(Teuchos::RCP< Teuchos::Comm< int > const > const &)");; @@ -840,8 +842,8 @@ SWIGEXPORT void _wrap_TrilinosSolver_setup_matrix(SwigClassWrapper const *farg1, Teuchos::RCP< ForTrilinos::TrilinosSolver::Matrix > tempnull2 ; SWIG_check_mutable_nonnull(*farg1, "ForTrilinos::TrilinosSolver *", "TrilinosSolver", "ForTrilinos::TrilinosSolver::setup_matrix(Teuchos::RCP< ForTrilinos::TrilinosSolver::Matrix > const &)", return ); - arg1 = static_cast< ForTrilinos::TrilinosSolver * >(farg1->ptr); - arg2 = farg2->ptr ? static_cast< Teuchos::RCP< ForTrilinos::TrilinosSolver::Matrix > * >(farg2->ptr) : &tempnull2; + arg1 = static_cast< ForTrilinos::TrilinosSolver * >(farg1->cptr); + arg2 = farg2->cptr ? static_cast< Teuchos::RCP< ForTrilinos::TrilinosSolver::Matrix > * >(farg2->cptr) : &tempnull2; { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("ForTrilinos::TrilinosSolver::setup_matrix(Teuchos::RCP< ForTrilinos::TrilinosSolver::Matrix > const &)");; @@ -875,8 +877,8 @@ SWIGEXPORT void _wrap_TrilinosSolver_setup_operator(SwigClassWrapper const *farg Teuchos::RCP< ForTrilinos::TrilinosSolver::Operator > tempnull2 ; SWIG_check_mutable_nonnull(*farg1, "ForTrilinos::TrilinosSolver *", "TrilinosSolver", "ForTrilinos::TrilinosSolver::setup_operator(Teuchos::RCP< ForTrilinos::TrilinosSolver::Operator > const &)", return ); - arg1 = static_cast< ForTrilinos::TrilinosSolver * >(farg1->ptr); - arg2 = farg2->ptr ? static_cast< Teuchos::RCP< ForTrilinos::TrilinosSolver::Operator > * >(farg2->ptr) : &tempnull2; + arg1 = static_cast< ForTrilinos::TrilinosSolver * >(farg1->cptr); + arg2 = farg2->cptr ? static_cast< Teuchos::RCP< ForTrilinos::TrilinosSolver::Operator > * >(farg2->cptr) : &tempnull2; { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("ForTrilinos::TrilinosSolver::setup_operator(Teuchos::RCP< ForTrilinos::TrilinosSolver::Operator > const &)");; @@ -910,8 +912,8 @@ SWIGEXPORT void _wrap_TrilinosSolver_setup_solver(SwigClassWrapper const *farg1, Teuchos::RCP< Teuchos::ParameterList > tempnull2 ; SWIG_check_mutable_nonnull(*farg1, "ForTrilinos::TrilinosSolver *", "TrilinosSolver", "ForTrilinos::TrilinosSolver::setup_solver(Teuchos::RCP< Teuchos::ParameterList > const &)", return ); - arg1 = static_cast< ForTrilinos::TrilinosSolver * >(farg1->ptr); - arg2 = farg2->ptr ? static_cast< Teuchos::RCP< Teuchos::ParameterList > * >(farg2->ptr) : &tempnull2; + arg1 = static_cast< ForTrilinos::TrilinosSolver * >(farg1->cptr); + arg2 = farg2->cptr ? static_cast< Teuchos::RCP< Teuchos::ParameterList > * >(farg2->cptr) : &tempnull2; { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("ForTrilinos::TrilinosSolver::setup_solver(Teuchos::RCP< Teuchos::ParameterList > const &)");; @@ -947,9 +949,9 @@ SWIGEXPORT void _wrap_TrilinosSolver_solve(SwigClassWrapper const *farg1, SwigCl Teuchos::RCP< ForTrilinos::TrilinosSolver::MultiVector > tempnull3 ; SWIG_check_nonnull(*farg1, "ForTrilinos::TrilinosSolver const *", "TrilinosSolver", "ForTrilinos::TrilinosSolver::solve(Teuchos::RCP< ForTrilinos::TrilinosSolver::MultiVector const > const &,Teuchos::RCP< ForTrilinos::TrilinosSolver::MultiVector > &) const", return ); - arg1 = static_cast< ForTrilinos::TrilinosSolver * >(farg1->ptr); - arg2 = farg2->ptr ? static_cast< Teuchos::RCP< ForTrilinos::TrilinosSolver::MultiVector const > * >(farg2->ptr) : &tempnull2; - arg3 = farg3->ptr ? static_cast< Teuchos::RCP< ForTrilinos::TrilinosSolver::MultiVector > * >(farg3->ptr) : &tempnull3; + arg1 = static_cast< ForTrilinos::TrilinosSolver * >(farg1->cptr); + arg2 = farg2->cptr ? static_cast< Teuchos::RCP< ForTrilinos::TrilinosSolver::MultiVector const > * >(farg2->cptr) : &tempnull2; + arg3 = farg3->cptr ? static_cast< Teuchos::RCP< ForTrilinos::TrilinosSolver::MultiVector > * >(farg3->cptr) : &tempnull3; { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("ForTrilinos::TrilinosSolver::solve(Teuchos::RCP< ForTrilinos::TrilinosSolver::MultiVector const > const &,Teuchos::RCP< ForTrilinos::TrilinosSolver::MultiVector > &) const");; @@ -981,7 +983,7 @@ SWIGEXPORT void _wrap_TrilinosSolver_finalize(SwigClassWrapper const *farg1) { ForTrilinos::TrilinosSolver *arg1 = (ForTrilinos::TrilinosSolver *) 0 ; SWIG_check_mutable_nonnull(*farg1, "ForTrilinos::TrilinosSolver *", "TrilinosSolver", "ForTrilinos::TrilinosSolver::finalize()", return ); - arg1 = static_cast< ForTrilinos::TrilinosSolver * >(farg1->ptr); + arg1 = static_cast< ForTrilinos::TrilinosSolver * >(farg1->cptr); { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("ForTrilinos::TrilinosSolver::finalize()");; @@ -1013,7 +1015,7 @@ SWIGEXPORT void _wrap_delete_TrilinosSolver(SwigClassWrapper const *farg1) { ForTrilinos::TrilinosSolver *arg1 = (ForTrilinos::TrilinosSolver *) 0 ; SWIG_check_mutable_nonnull(*farg1, "ForTrilinos::TrilinosSolver *", "TrilinosSolver", "ForTrilinos::TrilinosSolver::~TrilinosSolver()", return ); - arg1 = static_cast< ForTrilinos::TrilinosSolver * >(farg1->ptr); + arg1 = static_cast< ForTrilinos::TrilinosSolver * >(farg1->cptr); { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("ForTrilinos::TrilinosSolver::~TrilinosSolver()");; @@ -1042,7 +1044,7 @@ SWIGEXPORT void _wrap_delete_TrilinosSolver(SwigClassWrapper const *farg1) { SWIGEXPORT void _wrap_assign_TrilinosSolver(SwigClassWrapper * self, SwigClassWrapper const * other) { - typedef ::ForTrilinos::TrilinosSolver swig_lhs_classtype; + typedef ForTrilinos::TrilinosSolver swig_lhs_classtype; SWIG_assign(swig_lhs_classtype, self, swig_lhs_classtype, const_cast(other), 0 | swig::IS_DESTR | swig::IS_COPY_CONSTR); @@ -1076,7 +1078,7 @@ SWIGEXPORT SwigClassWrapper _wrap_new_TrilinosEigenSolver() { SWIG_exception_impl("ForTrilinos::TrilinosEigenSolver::TrilinosEigenSolver()", SWIG_UnknownError, "An unknown exception occurred", return SwigClassWrapper_uninitialized()); } } - fresult.ptr = result; + fresult.cptr = result; fresult.mem = (1 ? SWIG_MOVE : SWIG_REF); return fresult; } @@ -1086,7 +1088,7 @@ SWIGEXPORT void _wrap_TrilinosEigenSolver_init__SWIG_0(SwigClassWrapper const *f ForTrilinos::TrilinosEigenSolver *arg1 = (ForTrilinos::TrilinosEigenSolver *) 0 ; SWIG_check_mutable_nonnull(*farg1, "ForTrilinos::TrilinosEigenSolver *", "TrilinosEigenSolver", "ForTrilinos::TrilinosEigenSolver::init()", return ); - arg1 = static_cast< ForTrilinos::TrilinosEigenSolver * >(farg1->ptr); + arg1 = static_cast< ForTrilinos::TrilinosEigenSolver * >(farg1->cptr); { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("ForTrilinos::TrilinosEigenSolver::init()");; @@ -1120,8 +1122,8 @@ SWIGEXPORT void _wrap_TrilinosEigenSolver_init__SWIG_1(SwigClassWrapper const *f Teuchos::RCP< Teuchos::Comm< int > const > tempnull2 ; SWIG_check_mutable_nonnull(*farg1, "ForTrilinos::TrilinosEigenSolver *", "TrilinosEigenSolver", "ForTrilinos::TrilinosEigenSolver::init(Teuchos::RCP< Teuchos::Comm< int > const > const &)", return ); - arg1 = static_cast< ForTrilinos::TrilinosEigenSolver * >(farg1->ptr); - arg2 = farg2->ptr ? static_cast< Teuchos::RCP< Teuchos::Comm< int > const > * >(farg2->ptr) : &tempnull2; + arg1 = static_cast< ForTrilinos::TrilinosEigenSolver * >(farg1->cptr); + arg2 = farg2->cptr ? static_cast< Teuchos::RCP< Teuchos::Comm< int > const > * >(farg2->cptr) : &tempnull2; { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("ForTrilinos::TrilinosEigenSolver::init(Teuchos::RCP< Teuchos::Comm< int > const > const &)");; @@ -1155,8 +1157,8 @@ SWIGEXPORT void _wrap_TrilinosEigenSolver_setup_matrix(SwigClassWrapper const *f Teuchos::RCP< ForTrilinos::TrilinosEigenSolver::Matrix > tempnull2 ; SWIG_check_mutable_nonnull(*farg1, "ForTrilinos::TrilinosEigenSolver *", "TrilinosEigenSolver", "ForTrilinos::TrilinosEigenSolver::setup_matrix(Teuchos::RCP< ForTrilinos::TrilinosEigenSolver::Matrix > const &)", return ); - arg1 = static_cast< ForTrilinos::TrilinosEigenSolver * >(farg1->ptr); - arg2 = farg2->ptr ? static_cast< Teuchos::RCP< ForTrilinos::TrilinosEigenSolver::Matrix > * >(farg2->ptr) : &tempnull2; + arg1 = static_cast< ForTrilinos::TrilinosEigenSolver * >(farg1->cptr); + arg2 = farg2->cptr ? static_cast< Teuchos::RCP< ForTrilinos::TrilinosEigenSolver::Matrix > * >(farg2->cptr) : &tempnull2; { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("ForTrilinos::TrilinosEigenSolver::setup_matrix(Teuchos::RCP< ForTrilinos::TrilinosEigenSolver::Matrix > const &)");; @@ -1190,8 +1192,8 @@ SWIGEXPORT void _wrap_TrilinosEigenSolver_setup_matrix_rhs(SwigClassWrapper cons Teuchos::RCP< ForTrilinos::TrilinosEigenSolver::Matrix > tempnull2 ; SWIG_check_mutable_nonnull(*farg1, "ForTrilinos::TrilinosEigenSolver *", "TrilinosEigenSolver", "ForTrilinos::TrilinosEigenSolver::setup_matrix_rhs(Teuchos::RCP< ForTrilinos::TrilinosEigenSolver::Matrix > const &)", return ); - arg1 = static_cast< ForTrilinos::TrilinosEigenSolver * >(farg1->ptr); - arg2 = farg2->ptr ? static_cast< Teuchos::RCP< ForTrilinos::TrilinosEigenSolver::Matrix > * >(farg2->ptr) : &tempnull2; + arg1 = static_cast< ForTrilinos::TrilinosEigenSolver * >(farg1->cptr); + arg2 = farg2->cptr ? static_cast< Teuchos::RCP< ForTrilinos::TrilinosEigenSolver::Matrix > * >(farg2->cptr) : &tempnull2; { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("ForTrilinos::TrilinosEigenSolver::setup_matrix_rhs(Teuchos::RCP< ForTrilinos::TrilinosEigenSolver::Matrix > const &)");; @@ -1225,8 +1227,8 @@ SWIGEXPORT void _wrap_TrilinosEigenSolver_setup_operator(SwigClassWrapper const Teuchos::RCP< ForTrilinos::TrilinosEigenSolver::Operator > tempnull2 ; SWIG_check_mutable_nonnull(*farg1, "ForTrilinos::TrilinosEigenSolver *", "TrilinosEigenSolver", "ForTrilinos::TrilinosEigenSolver::setup_operator(Teuchos::RCP< ForTrilinos::TrilinosEigenSolver::Operator > const &)", return ); - arg1 = static_cast< ForTrilinos::TrilinosEigenSolver * >(farg1->ptr); - arg2 = farg2->ptr ? static_cast< Teuchos::RCP< ForTrilinos::TrilinosEigenSolver::Operator > * >(farg2->ptr) : &tempnull2; + arg1 = static_cast< ForTrilinos::TrilinosEigenSolver * >(farg1->cptr); + arg2 = farg2->cptr ? static_cast< Teuchos::RCP< ForTrilinos::TrilinosEigenSolver::Operator > * >(farg2->cptr) : &tempnull2; { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("ForTrilinos::TrilinosEigenSolver::setup_operator(Teuchos::RCP< ForTrilinos::TrilinosEigenSolver::Operator > const &)");; @@ -1260,8 +1262,8 @@ SWIGEXPORT void _wrap_TrilinosEigenSolver_setup_operator_rhs(SwigClassWrapper co Teuchos::RCP< ForTrilinos::TrilinosEigenSolver::Operator > tempnull2 ; SWIG_check_mutable_nonnull(*farg1, "ForTrilinos::TrilinosEigenSolver *", "TrilinosEigenSolver", "ForTrilinos::TrilinosEigenSolver::setup_operator_rhs(Teuchos::RCP< ForTrilinos::TrilinosEigenSolver::Operator > const &)", return ); - arg1 = static_cast< ForTrilinos::TrilinosEigenSolver * >(farg1->ptr); - arg2 = farg2->ptr ? static_cast< Teuchos::RCP< ForTrilinos::TrilinosEigenSolver::Operator > * >(farg2->ptr) : &tempnull2; + arg1 = static_cast< ForTrilinos::TrilinosEigenSolver * >(farg1->cptr); + arg2 = farg2->cptr ? static_cast< Teuchos::RCP< ForTrilinos::TrilinosEigenSolver::Operator > * >(farg2->cptr) : &tempnull2; { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("ForTrilinos::TrilinosEigenSolver::setup_operator_rhs(Teuchos::RCP< ForTrilinos::TrilinosEigenSolver::Operator > const &)");; @@ -1295,8 +1297,8 @@ SWIGEXPORT void _wrap_TrilinosEigenSolver_setup_solver(SwigClassWrapper const *f Teuchos::RCP< Teuchos::ParameterList > tempnull2 ; SWIG_check_mutable_nonnull(*farg1, "ForTrilinos::TrilinosEigenSolver *", "TrilinosEigenSolver", "ForTrilinos::TrilinosEigenSolver::setup_solver(Teuchos::RCP< Teuchos::ParameterList > const &)", return ); - arg1 = static_cast< ForTrilinos::TrilinosEigenSolver * >(farg1->ptr); - arg2 = farg2->ptr ? static_cast< Teuchos::RCP< Teuchos::ParameterList > * >(farg2->ptr) : &tempnull2; + arg1 = static_cast< ForTrilinos::TrilinosEigenSolver * >(farg1->cptr); + arg2 = farg2->cptr ? static_cast< Teuchos::RCP< Teuchos::ParameterList > * >(farg2->cptr) : &tempnull2; { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("ForTrilinos::TrilinosEigenSolver::setup_solver(Teuchos::RCP< Teuchos::ParameterList > const &)");; @@ -1334,10 +1336,10 @@ SWIGEXPORT size_t _wrap_TrilinosEigenSolver_solve(SwigClassWrapper const *farg1, size_t result; SWIG_check_nonnull(*farg1, "ForTrilinos::TrilinosEigenSolver const *", "TrilinosEigenSolver", "ForTrilinos::TrilinosEigenSolver::solve(std::pair< ForTrilinos::TrilinosEigenSolver::SC *,std::size_t >,Teuchos::RCP< ForTrilinos::TrilinosEigenSolver::MultiVector > &,std::pair< int *,std::size_t >) const", return 0); - arg1 = static_cast< ForTrilinos::TrilinosEigenSolver * >(farg1->ptr); + arg1 = static_cast< ForTrilinos::TrilinosEigenSolver * >(farg1->cptr); (&arg2)->first = static_cast(farg2->data); (&arg2)->second = farg2->size; - arg3 = farg3->ptr ? static_cast< Teuchos::RCP< ForTrilinos::TrilinosEigenSolver::MultiVector > * >(farg3->ptr) : &tempnull3; + arg3 = farg3->cptr ? static_cast< Teuchos::RCP< ForTrilinos::TrilinosEigenSolver::MultiVector > * >(farg3->cptr) : &tempnull3; (&arg4)->first = static_cast(farg4->data); (&arg4)->second = farg4->size; { @@ -1363,7 +1365,7 @@ SWIGEXPORT size_t _wrap_TrilinosEigenSolver_solve(SwigClassWrapper const *farg1, SWIG_exception_impl("ForTrilinos::TrilinosEigenSolver::solve(std::pair< ForTrilinos::TrilinosEigenSolver::SC *,std::size_t >,Teuchos::RCP< ForTrilinos::TrilinosEigenSolver::MultiVector > &,std::pair< int *,std::size_t >) const", SWIG_UnknownError, "An unknown exception occurred", return 0); } } - fresult = result; + fresult = static_cast< size_t >(result); return fresult; } @@ -1372,7 +1374,7 @@ SWIGEXPORT void _wrap_TrilinosEigenSolver_finalize(SwigClassWrapper const *farg1 ForTrilinos::TrilinosEigenSolver *arg1 = (ForTrilinos::TrilinosEigenSolver *) 0 ; SWIG_check_mutable_nonnull(*farg1, "ForTrilinos::TrilinosEigenSolver *", "TrilinosEigenSolver", "ForTrilinos::TrilinosEigenSolver::finalize()", return ); - arg1 = static_cast< ForTrilinos::TrilinosEigenSolver * >(farg1->ptr); + arg1 = static_cast< ForTrilinos::TrilinosEigenSolver * >(farg1->cptr); { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("ForTrilinos::TrilinosEigenSolver::finalize()");; @@ -1404,7 +1406,7 @@ SWIGEXPORT void _wrap_delete_TrilinosEigenSolver(SwigClassWrapper const *farg1) ForTrilinos::TrilinosEigenSolver *arg1 = (ForTrilinos::TrilinosEigenSolver *) 0 ; SWIG_check_mutable_nonnull(*farg1, "ForTrilinos::TrilinosEigenSolver *", "TrilinosEigenSolver", "ForTrilinos::TrilinosEigenSolver::~TrilinosEigenSolver()", return ); - arg1 = static_cast< ForTrilinos::TrilinosEigenSolver * >(farg1->ptr); + arg1 = static_cast< ForTrilinos::TrilinosEigenSolver * >(farg1->cptr); { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("ForTrilinos::TrilinosEigenSolver::~TrilinosEigenSolver()");; @@ -1433,7 +1435,7 @@ SWIGEXPORT void _wrap_delete_TrilinosEigenSolver(SwigClassWrapper const *farg1) SWIGEXPORT void _wrap_assign_TrilinosEigenSolver(SwigClassWrapper * self, SwigClassWrapper const * other) { - typedef ::ForTrilinos::TrilinosEigenSolver swig_lhs_classtype; + typedef ForTrilinos::TrilinosEigenSolver swig_lhs_classtype; SWIG_assign(swig_lhs_classtype, self, swig_lhs_classtype, const_cast(other), 0 | swig::IS_DESTR | swig::IS_COPY_CONSTR); @@ -1448,10 +1450,10 @@ SWIGEXPORT void _wrap_ForTrilinosModelEvaluator_evaluate_residual(SwigClassWrapp Teuchos::RCP< ForTrilinos::ModelEvaluator< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::MultiVector const > tempnull2 ; Teuchos::RCP< ForTrilinos::ModelEvaluator< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::MultiVector > tempnull3 ; - smartarg1 = static_cast< Teuchos::RCP >* >(farg1->ptr); - arg1 = smartarg1 ? const_cast*>(smartarg1->get()) : NULL; - arg2 = farg2->ptr ? static_cast< Teuchos::RCP< ForTrilinos::ModelEvaluator< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::MultiVector const > * >(farg2->ptr) : &tempnull2; - arg3 = farg3->ptr ? static_cast< Teuchos::RCP< ForTrilinos::ModelEvaluator< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::MultiVector > * >(farg3->ptr) : &tempnull3; + smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< ForTrilinos::ModelEvaluator* >(smartarg1->get()) : NULL; + arg2 = farg2->cptr ? static_cast< Teuchos::RCP< ForTrilinos::ModelEvaluator< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::MultiVector const > * >(farg2->cptr) : &tempnull2; + arg3 = farg3->cptr ? static_cast< Teuchos::RCP< ForTrilinos::ModelEvaluator< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::MultiVector > * >(farg3->cptr) : &tempnull3; { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("ForTrilinos::ModelEvaluator< SC,LO,GO,NO >::evaluate_residual(Teuchos::RCP< ForTrilinos::ModelEvaluator< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::MultiVector const > const &,Teuchos::RCP< ForTrilinos::ModelEvaluator< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::MultiVector > &) const");; @@ -1487,10 +1489,10 @@ SWIGEXPORT void _wrap_ForTrilinosModelEvaluator_evaluate_jacobian(SwigClassWrapp Teuchos::RCP< ForTrilinos::ModelEvaluator< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::MultiVector const > tempnull2 ; Teuchos::RCP< ForTrilinos::ModelEvaluator< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::Operator > tempnull3 ; - smartarg1 = static_cast< Teuchos::RCP >* >(farg1->ptr); - arg1 = smartarg1 ? const_cast*>(smartarg1->get()) : NULL; - arg2 = farg2->ptr ? static_cast< Teuchos::RCP< ForTrilinos::ModelEvaluator< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::MultiVector const > * >(farg2->ptr) : &tempnull2; - arg3 = farg3->ptr ? static_cast< Teuchos::RCP< ForTrilinos::ModelEvaluator< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::Operator > * >(farg3->ptr) : &tempnull3; + smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< ForTrilinos::ModelEvaluator* >(smartarg1->get()) : NULL; + arg2 = farg2->cptr ? static_cast< Teuchos::RCP< ForTrilinos::ModelEvaluator< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::MultiVector const > * >(farg2->cptr) : &tempnull2; + arg3 = farg3->cptr ? static_cast< Teuchos::RCP< ForTrilinos::ModelEvaluator< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::Operator > * >(farg3->cptr) : &tempnull3; { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("ForTrilinos::ModelEvaluator< SC,LO,GO,NO >::evaluate_jacobian(Teuchos::RCP< ForTrilinos::ModelEvaluator< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::MultiVector const > const &,Teuchos::RCP< ForTrilinos::ModelEvaluator< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::Operator > &) const");; @@ -1526,10 +1528,10 @@ SWIGEXPORT void _wrap_ForTrilinosModelEvaluator_evaluate_preconditioner(SwigClas Teuchos::RCP< ForTrilinos::ModelEvaluator< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::MultiVector const > tempnull2 ; Teuchos::RCP< ForTrilinos::ModelEvaluator< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::Operator > tempnull3 ; - smartarg1 = static_cast< Teuchos::RCP >* >(farg1->ptr); - arg1 = smartarg1 ? const_cast*>(smartarg1->get()) : NULL; - arg2 = farg2->ptr ? static_cast< Teuchos::RCP< ForTrilinos::ModelEvaluator< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::MultiVector const > * >(farg2->ptr) : &tempnull2; - arg3 = farg3->ptr ? static_cast< Teuchos::RCP< ForTrilinos::ModelEvaluator< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::Operator > * >(farg3->ptr) : &tempnull3; + smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< ForTrilinos::ModelEvaluator* >(smartarg1->get()) : NULL; + arg2 = farg2->cptr ? static_cast< Teuchos::RCP< ForTrilinos::ModelEvaluator< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::MultiVector const > * >(farg2->cptr) : &tempnull2; + arg3 = farg3->cptr ? static_cast< Teuchos::RCP< ForTrilinos::ModelEvaluator< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::Operator > * >(farg3->cptr) : &tempnull3; { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("ForTrilinos::ModelEvaluator< SC,LO,GO,NO >::evaluate_preconditioner(Teuchos::RCP< ForTrilinos::ModelEvaluator< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::MultiVector const > const &,Teuchos::RCP< ForTrilinos::ModelEvaluator< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::Operator > &) const");; @@ -1563,8 +1565,8 @@ SWIGEXPORT SwigClassWrapper _wrap_ForTrilinosModelEvaluator_get_x_map(SwigClassW Teuchos::RCP< ForTrilinos::ModelEvaluator< SC,LO,GO,NO > const > *smartarg1 ; Teuchos::RCP< ForTrilinos::ModelEvaluator< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::Map const > result; - smartarg1 = static_cast< Teuchos::RCP >* >(farg1->ptr); - arg1 = smartarg1 ? const_cast*>(smartarg1->get()) : NULL; + smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< ForTrilinos::ModelEvaluator* >(smartarg1->get()) : NULL; { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("ForTrilinos::ModelEvaluator< SC,LO,GO,NO >::get_x_map() const");; @@ -1588,7 +1590,7 @@ SWIGEXPORT SwigClassWrapper _wrap_ForTrilinosModelEvaluator_get_x_map(SwigClassW SWIG_exception_impl("ForTrilinos::ModelEvaluator< SC,LO,GO,NO >::get_x_map() const", SWIG_UnknownError, "An unknown exception occurred", return SwigClassWrapper_uninitialized()); } } - fresult.ptr = (new Teuchos::RCP >(static_cast< const Teuchos::RCP >& >(result))); + fresult.cptr = (new Teuchos::RCP >(static_cast< const Teuchos::RCP >& >(result))); fresult.mem = SWIG_MOVE; return fresult; } @@ -1600,8 +1602,8 @@ SWIGEXPORT SwigClassWrapper _wrap_ForTrilinosModelEvaluator_get_f_map(SwigClassW Teuchos::RCP< ForTrilinos::ModelEvaluator< SC,LO,GO,NO > const > *smartarg1 ; Teuchos::RCP< ForTrilinos::ModelEvaluator< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::Map const > result; - smartarg1 = static_cast< Teuchos::RCP >* >(farg1->ptr); - arg1 = smartarg1 ? const_cast*>(smartarg1->get()) : NULL; + smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< ForTrilinos::ModelEvaluator* >(smartarg1->get()) : NULL; { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("ForTrilinos::ModelEvaluator< SC,LO,GO,NO >::get_f_map() const");; @@ -1625,7 +1627,7 @@ SWIGEXPORT SwigClassWrapper _wrap_ForTrilinosModelEvaluator_get_f_map(SwigClassW SWIG_exception_impl("ForTrilinos::ModelEvaluator< SC,LO,GO,NO >::get_f_map() const", SWIG_UnknownError, "An unknown exception occurred", return SwigClassWrapper_uninitialized()); } } - fresult.ptr = (new Teuchos::RCP >(static_cast< const Teuchos::RCP >& >(result))); + fresult.cptr = (new Teuchos::RCP >(static_cast< const Teuchos::RCP >& >(result))); fresult.mem = SWIG_MOVE; return fresult; } @@ -1637,8 +1639,8 @@ SWIGEXPORT SwigClassWrapper _wrap_ForTrilinosModelEvaluator_create_operator(Swig Teuchos::RCP< ForTrilinos::ModelEvaluator< SC,LO,GO,NO > const > *smartarg1 ; Teuchos::RCP< ForTrilinos::ModelEvaluator< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::Operator > result; - smartarg1 = static_cast< Teuchos::RCP >* >(farg1->ptr); - arg1 = smartarg1 ? const_cast*>(smartarg1->get()) : NULL; + smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< ForTrilinos::ModelEvaluator* >(smartarg1->get()) : NULL; { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("ForTrilinos::ModelEvaluator< SC,LO,GO,NO >::create_operator() const");; @@ -1662,7 +1664,7 @@ SWIGEXPORT SwigClassWrapper _wrap_ForTrilinosModelEvaluator_create_operator(Swig SWIG_exception_impl("ForTrilinos::ModelEvaluator< SC,LO,GO,NO >::create_operator() const", SWIG_UnknownError, "An unknown exception occurred", return SwigClassWrapper_uninitialized()); } } - fresult.ptr = (new Teuchos::RCP< Tpetra::Operator >(static_cast< const Teuchos::RCP< Tpetra::Operator >& >(result))); + fresult.cptr = (new Teuchos::RCP< Tpetra::Operator >(static_cast< const Teuchos::RCP< Tpetra::Operator >& >(result))); fresult.mem = SWIG_MOVE; return fresult; } @@ -1674,9 +1676,9 @@ SWIGEXPORT void _wrap_ForTrilinosModelEvaluator_setup(SwigClassWrapper const *fa Teuchos::RCP< ForTrilinos::ModelEvaluator< SC,LO,GO,NO > > *smartarg1 ; Teuchos::RCP< Teuchos::ParameterList > tempnull2 ; - smartarg1 = static_cast< Teuchos::RCP< ForTrilinos::ModelEvaluator >* >(farg1->ptr); - arg1 = smartarg1 ? smartarg1->get() : NULL; - arg2 = farg2->ptr ? static_cast< Teuchos::RCP< Teuchos::ParameterList > * >(farg2->ptr) : &tempnull2; + smartarg1 = static_cast< Teuchos::RCP< ForTrilinos::ModelEvaluator >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< ForTrilinos::ModelEvaluator* >(smartarg1->get()) : NULL; + arg2 = farg2->cptr ? static_cast< Teuchos::RCP< Teuchos::ParameterList > * >(farg2->cptr) : &tempnull2; { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("ForTrilinos::ModelEvaluator< SC,LO,GO,NO >::setup(Teuchos::RCP< Teuchos::ParameterList > &)");; @@ -1708,8 +1710,8 @@ SWIGEXPORT void _wrap_delete_ForTrilinosModelEvaluator(SwigClassWrapper const *f ForTrilinos::ModelEvaluator< SC,LO,GO,NO > *arg1 = (ForTrilinos::ModelEvaluator< SC,LO,GO,NO > *) 0 ; Teuchos::RCP< ForTrilinos::ModelEvaluator< SC,LO,GO,NO > > *smartarg1 ; - smartarg1 = static_cast< Teuchos::RCP< ForTrilinos::ModelEvaluator >* >(farg1->ptr); - arg1 = smartarg1 ? smartarg1->get() : NULL; + smartarg1 = static_cast< Teuchos::RCP< ForTrilinos::ModelEvaluator >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< ForTrilinos::ModelEvaluator* >(smartarg1->get()) : NULL; { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("ForTrilinos::ModelEvaluator< SC,LO,GO,NO >::~ModelEvaluator()");; @@ -1738,7 +1740,7 @@ SWIGEXPORT void _wrap_delete_ForTrilinosModelEvaluator(SwigClassWrapper const *f SWIGEXPORT void _wrap_assign_ForTrilinosModelEvaluator(SwigClassWrapper * self, SwigClassWrapper const * other) { - typedef ::Teuchos::RCP< ForTrilinos::ModelEvaluator > swig_lhs_classtype; + typedef Teuchos::RCP< ForTrilinos::ModelEvaluator > swig_lhs_classtype; SWIG_assign(swig_lhs_classtype, self, swig_lhs_classtype, const_cast(other), 0 | swig::IS_DESTR); @@ -1751,8 +1753,8 @@ SWIGEXPORT void * _wrap_ForModelEvaluator_fhandle(SwigClassWrapper const *farg1) Teuchos::RCP< ForModelEvaluator const > *smartarg1 ; void *result = 0 ; - smartarg1 = static_cast< Teuchos::RCP* >(farg1->ptr); - arg1 = smartarg1 ? const_cast(smartarg1->get()) : NULL; + smartarg1 = static_cast< Teuchos::RCP* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< ForModelEvaluator* >(smartarg1->get()) : NULL; { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("ForModelEvaluator::fhandle() const");; @@ -1786,8 +1788,8 @@ SWIGEXPORT void _wrap_ForModelEvaluator_init(SwigClassWrapper const *farg1, void void *arg2 = (void *) 0 ; Teuchos::RCP< ForModelEvaluator > *smartarg1 ; - smartarg1 = static_cast< Teuchos::RCP< ForModelEvaluator >* >(farg1->ptr); - arg1 = smartarg1 ? smartarg1->get() : NULL; + smartarg1 = static_cast< Teuchos::RCP< ForModelEvaluator >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< ForModelEvaluator* >(smartarg1->get()) : NULL; arg2 = reinterpret_cast< void * >(farg2); { // Make sure no unhandled exceptions exist before performing a new action @@ -1822,9 +1824,9 @@ SWIGEXPORT void _wrap_ForModelEvaluator_setup(SwigClassWrapper const *farg1, Swi Teuchos::RCP< ForModelEvaluator > *smartarg1 ; Teuchos::RCP< Teuchos::ParameterList > tempnull2 ; - smartarg1 = static_cast< Teuchos::RCP< ForModelEvaluator >* >(farg1->ptr); - arg1 = smartarg1 ? smartarg1->get() : NULL; - arg2 = farg2->ptr ? static_cast< Teuchos::RCP< Teuchos::ParameterList > * >(farg2->ptr) : &tempnull2; + smartarg1 = static_cast< Teuchos::RCP< ForModelEvaluator >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< ForModelEvaluator* >(smartarg1->get()) : NULL; + arg2 = farg2->cptr ? static_cast< Teuchos::RCP< Teuchos::ParameterList > * >(farg2->cptr) : &tempnull2; { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("ForModelEvaluator::setup(Teuchos::RCP< Teuchos::ParameterList > &)");; @@ -1860,10 +1862,10 @@ SWIGEXPORT void _wrap_ForModelEvaluator_evaluate_residual(SwigClassWrapper const Teuchos::RCP< ForModelEvaluator::multivector_type const > tempnull2 ; Teuchos::RCP< ForModelEvaluator::multivector_type > tempnull3 ; - smartarg1 = static_cast< Teuchos::RCP* >(farg1->ptr); - arg1 = smartarg1 ? const_cast(smartarg1->get()) : NULL; - arg2 = farg2->ptr ? static_cast< Teuchos::RCP< ForModelEvaluator::multivector_type const > * >(farg2->ptr) : &tempnull2; - arg3 = farg3->ptr ? static_cast< Teuchos::RCP< ForModelEvaluator::multivector_type > * >(farg3->ptr) : &tempnull3; + smartarg1 = static_cast< Teuchos::RCP* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< ForModelEvaluator* >(smartarg1->get()) : NULL; + arg2 = farg2->cptr ? static_cast< Teuchos::RCP< ForModelEvaluator::multivector_type const > * >(farg2->cptr) : &tempnull2; + arg3 = farg3->cptr ? static_cast< Teuchos::RCP< ForModelEvaluator::multivector_type > * >(farg3->cptr) : &tempnull3; { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("ForModelEvaluator::evaluate_residual(Teuchos::RCP< ForModelEvaluator::multivector_type const > const &,Teuchos::RCP< ForModelEvaluator::multivector_type > &) const");; @@ -1899,10 +1901,10 @@ SWIGEXPORT void _wrap_ForModelEvaluator_evaluate_jacobian(SwigClassWrapper const Teuchos::RCP< ForModelEvaluator::multivector_type const > tempnull2 ; Teuchos::RCP< ForModelEvaluator::operator_type > tempnull3 ; - smartarg1 = static_cast< Teuchos::RCP* >(farg1->ptr); - arg1 = smartarg1 ? const_cast(smartarg1->get()) : NULL; - arg2 = farg2->ptr ? static_cast< Teuchos::RCP< ForModelEvaluator::multivector_type const > * >(farg2->ptr) : &tempnull2; - arg3 = farg3->ptr ? static_cast< Teuchos::RCP< ForModelEvaluator::operator_type > * >(farg3->ptr) : &tempnull3; + smartarg1 = static_cast< Teuchos::RCP* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< ForModelEvaluator* >(smartarg1->get()) : NULL; + arg2 = farg2->cptr ? static_cast< Teuchos::RCP< ForModelEvaluator::multivector_type const > * >(farg2->cptr) : &tempnull2; + arg3 = farg3->cptr ? static_cast< Teuchos::RCP< ForModelEvaluator::operator_type > * >(farg3->cptr) : &tempnull3; { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("ForModelEvaluator::evaluate_jacobian(Teuchos::RCP< ForModelEvaluator::multivector_type const > const &,Teuchos::RCP< ForModelEvaluator::operator_type > &) const");; @@ -1938,10 +1940,10 @@ SWIGEXPORT void _wrap_ForModelEvaluator_evaluate_preconditioner(SwigClassWrapper Teuchos::RCP< ForModelEvaluator::multivector_type const > tempnull2 ; Teuchos::RCP< ForModelEvaluator::operator_type > tempnull3 ; - smartarg1 = static_cast< Teuchos::RCP* >(farg1->ptr); - arg1 = smartarg1 ? const_cast(smartarg1->get()) : NULL; - arg2 = farg2->ptr ? static_cast< Teuchos::RCP< ForModelEvaluator::multivector_type const > * >(farg2->ptr) : &tempnull2; - arg3 = farg3->ptr ? static_cast< Teuchos::RCP< ForModelEvaluator::operator_type > * >(farg3->ptr) : &tempnull3; + smartarg1 = static_cast< Teuchos::RCP* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< ForModelEvaluator* >(smartarg1->get()) : NULL; + arg2 = farg2->cptr ? static_cast< Teuchos::RCP< ForModelEvaluator::multivector_type const > * >(farg2->cptr) : &tempnull2; + arg3 = farg3->cptr ? static_cast< Teuchos::RCP< ForModelEvaluator::operator_type > * >(farg3->cptr) : &tempnull3; { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("ForModelEvaluator::evaluate_preconditioner(Teuchos::RCP< ForModelEvaluator::multivector_type const > const &,Teuchos::RCP< ForModelEvaluator::operator_type > &) const");; @@ -1975,8 +1977,8 @@ SWIGEXPORT SwigClassWrapper _wrap_ForModelEvaluator_get_x_map(SwigClassWrapper c Teuchos::RCP< ForModelEvaluator const > *smartarg1 ; Teuchos::RCP< ForModelEvaluator::map_type const > result; - smartarg1 = static_cast< Teuchos::RCP* >(farg1->ptr); - arg1 = smartarg1 ? const_cast(smartarg1->get()) : NULL; + smartarg1 = static_cast< Teuchos::RCP* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< ForModelEvaluator* >(smartarg1->get()) : NULL; { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("ForModelEvaluator::get_x_map() const");; @@ -2000,7 +2002,7 @@ SWIGEXPORT SwigClassWrapper _wrap_ForModelEvaluator_get_x_map(SwigClassWrapper c SWIG_exception_impl("ForModelEvaluator::get_x_map() const", SWIG_UnknownError, "An unknown exception occurred", return SwigClassWrapper_uninitialized()); } } - fresult.ptr = (new Teuchos::RCP >(static_cast< const Teuchos::RCP >& >(result))); + fresult.cptr = (new Teuchos::RCP >(static_cast< const Teuchos::RCP >& >(result))); fresult.mem = SWIG_MOVE; return fresult; } @@ -2012,8 +2014,8 @@ SWIGEXPORT SwigClassWrapper _wrap_ForModelEvaluator_get_f_map(SwigClassWrapper c Teuchos::RCP< ForModelEvaluator const > *smartarg1 ; Teuchos::RCP< ForModelEvaluator::map_type const > result; - smartarg1 = static_cast< Teuchos::RCP* >(farg1->ptr); - arg1 = smartarg1 ? const_cast(smartarg1->get()) : NULL; + smartarg1 = static_cast< Teuchos::RCP* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< ForModelEvaluator* >(smartarg1->get()) : NULL; { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("ForModelEvaluator::get_f_map() const");; @@ -2037,7 +2039,7 @@ SWIGEXPORT SwigClassWrapper _wrap_ForModelEvaluator_get_f_map(SwigClassWrapper c SWIG_exception_impl("ForModelEvaluator::get_f_map() const", SWIG_UnknownError, "An unknown exception occurred", return SwigClassWrapper_uninitialized()); } } - fresult.ptr = (new Teuchos::RCP >(static_cast< const Teuchos::RCP >& >(result))); + fresult.cptr = (new Teuchos::RCP >(static_cast< const Teuchos::RCP >& >(result))); fresult.mem = SWIG_MOVE; return fresult; } @@ -2049,8 +2051,8 @@ SWIGEXPORT SwigClassWrapper _wrap_ForModelEvaluator_create_operator(SwigClassWra Teuchos::RCP< ForModelEvaluator const > *smartarg1 ; Teuchos::RCP< ForModelEvaluator::operator_type > result; - smartarg1 = static_cast< Teuchos::RCP* >(farg1->ptr); - arg1 = smartarg1 ? const_cast(smartarg1->get()) : NULL; + smartarg1 = static_cast< Teuchos::RCP* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< ForModelEvaluator* >(smartarg1->get()) : NULL; { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("ForModelEvaluator::create_operator() const");; @@ -2074,7 +2076,7 @@ SWIGEXPORT SwigClassWrapper _wrap_ForModelEvaluator_create_operator(SwigClassWra SWIG_exception_impl("ForModelEvaluator::create_operator() const", SWIG_UnknownError, "An unknown exception occurred", return SwigClassWrapper_uninitialized()); } } - fresult.ptr = (new Teuchos::RCP< Tpetra::Operator >(static_cast< const Teuchos::RCP< Tpetra::Operator >& >(result))); + fresult.cptr = (new Teuchos::RCP< Tpetra::Operator >(static_cast< const Teuchos::RCP< Tpetra::Operator >& >(result))); fresult.mem = SWIG_MOVE; return fresult; } @@ -2107,7 +2109,7 @@ SWIGEXPORT SwigClassWrapper _wrap_new_ForModelEvaluator() { SWIG_exception_impl("ForModelEvaluator::ForModelEvaluator()", SWIG_UnknownError, "An unknown exception occurred", return SwigClassWrapper_uninitialized()); } } - fresult.ptr = result ? new Teuchos::RCP< ForModelEvaluator >(result SWIG_NO_NULL_DELETER_1) : NULL; + fresult.cptr = result ? new Teuchos::RCP< ForModelEvaluator >(result SWIG_NO_NULL_DELETER_1) : NULL; fresult.mem = SWIG_MOVE; return fresult; } @@ -2117,8 +2119,8 @@ SWIGEXPORT void _wrap_delete_ForModelEvaluator(SwigClassWrapper const *farg1) { ForModelEvaluator *arg1 = (ForModelEvaluator *) 0 ; Teuchos::RCP< ForModelEvaluator > *smartarg1 ; - smartarg1 = static_cast< Teuchos::RCP< ForModelEvaluator >* >(farg1->ptr); - arg1 = smartarg1 ? smartarg1->get() : NULL; + smartarg1 = static_cast< Teuchos::RCP< ForModelEvaluator >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< ForModelEvaluator* >(smartarg1->get()) : NULL; { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("ForModelEvaluator::~ForModelEvaluator()");; @@ -2147,7 +2149,7 @@ SWIGEXPORT void _wrap_delete_ForModelEvaluator(SwigClassWrapper const *farg1) { SWIGEXPORT void _wrap_assign_ForModelEvaluator(SwigClassWrapper * self, SwigClassWrapper const * other) { - typedef ::Teuchos::RCP< ForModelEvaluator > swig_lhs_classtype; + typedef Teuchos::RCP< ForModelEvaluator > swig_lhs_classtype; SWIG_assign(swig_lhs_classtype, self, swig_lhs_classtype, const_cast(other), 0 | swig::IS_DESTR | swig::IS_COPY_CONSTR); @@ -2160,7 +2162,7 @@ SWIGEXPORT SwigClassWrapper _wrap_new_NOXSolver(SwigClassWrapper const *farg1) { Teuchos::RCP< ForTrilinos::ModelEvaluator< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > > tempnull1 ; ForTrilinos::NOXSolver< SC,LO,GO,NO > *result = 0 ; - arg1 = farg1->ptr ? static_cast< Teuchos::RCP< ForTrilinos::ModelEvaluator< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > > * >(farg1->ptr) : &tempnull1; + arg1 = farg1->cptr ? static_cast< Teuchos::RCP< ForTrilinos::ModelEvaluator< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > > * >(farg1->cptr) : &tempnull1; { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("ForTrilinos::NOXSolver< SC,LO,GO,NO >::NOXSolver(Teuchos::RCP< ForTrilinos::ModelEvaluator< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > > const &)");; @@ -2184,7 +2186,7 @@ SWIGEXPORT SwigClassWrapper _wrap_new_NOXSolver(SwigClassWrapper const *farg1) { SWIG_exception_impl("ForTrilinos::NOXSolver< SC,LO,GO,NO >::NOXSolver(Teuchos::RCP< ForTrilinos::ModelEvaluator< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > > const &)", SWIG_UnknownError, "An unknown exception occurred", return SwigClassWrapper_uninitialized()); } } - fresult.ptr = result ? new Teuchos::RCP< ForTrilinos::NOXSolver >(result SWIG_NO_NULL_DELETER_1) : NULL; + fresult.cptr = result ? new Teuchos::RCP< ForTrilinos::NOXSolver >(result SWIG_NO_NULL_DELETER_1) : NULL; fresult.mem = SWIG_MOVE; return fresult; } @@ -2196,9 +2198,9 @@ SWIGEXPORT void _wrap_NOXSolver_setup(SwigClassWrapper const *farg1, SwigClassWr Teuchos::RCP< ForTrilinos::NOXSolver< SC,LO,GO,NO > > *smartarg1 ; Teuchos::RCP< Teuchos::ParameterList > tempnull2 ; - smartarg1 = static_cast< Teuchos::RCP< ForTrilinos::NOXSolver >* >(farg1->ptr); - arg1 = smartarg1 ? smartarg1->get() : NULL; - arg2 = farg2->ptr ? static_cast< Teuchos::RCP< Teuchos::ParameterList > * >(farg2->ptr) : &tempnull2; + smartarg1 = static_cast< Teuchos::RCP< ForTrilinos::NOXSolver >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< ForTrilinos::NOXSolver* >(smartarg1->get()) : NULL; + arg2 = farg2->cptr ? static_cast< Teuchos::RCP< Teuchos::ParameterList > * >(farg2->cptr) : &tempnull2; { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("ForTrilinos::NOXSolver< SC,LO,GO,NO >::setup(Teuchos::RCP< Teuchos::ParameterList > &)");; @@ -2232,8 +2234,8 @@ SWIGEXPORT int _wrap_NOXSolver_solve(SwigClassWrapper const *farg1) { Teuchos::RCP< ForTrilinos::NOXSolver< SC,LO,GO,NO > > *smartarg1 ; NOX::StatusTest::StatusType result; - smartarg1 = static_cast< Teuchos::RCP< ForTrilinos::NOXSolver >* >(farg1->ptr); - arg1 = smartarg1 ? smartarg1->get() : NULL; + smartarg1 = static_cast< Teuchos::RCP< ForTrilinos::NOXSolver >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< ForTrilinos::NOXSolver* >(smartarg1->get()) : NULL; { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("ForTrilinos::NOXSolver< SC,LO,GO,NO >::solve()");; @@ -2266,8 +2268,8 @@ SWIGEXPORT void _wrap_delete_NOXSolver(SwigClassWrapper const *farg1) { ForTrilinos::NOXSolver< SC,LO,GO,NO > *arg1 = (ForTrilinos::NOXSolver< SC,LO,GO,NO > *) 0 ; Teuchos::RCP< ForTrilinos::NOXSolver< SC,LO,GO,NO > > *smartarg1 ; - smartarg1 = static_cast< Teuchos::RCP< ForTrilinos::NOXSolver >* >(farg1->ptr); - arg1 = smartarg1 ? smartarg1->get() : NULL; + smartarg1 = static_cast< Teuchos::RCP< ForTrilinos::NOXSolver >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< ForTrilinos::NOXSolver* >(smartarg1->get()) : NULL; { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("ForTrilinos::NOXSolver< SC,LO,GO,NO >::~NOXSolver()");; @@ -2296,7 +2298,7 @@ SWIGEXPORT void _wrap_delete_NOXSolver(SwigClassWrapper const *farg1) { SWIGEXPORT void _wrap_assign_NOXSolver(SwigClassWrapper * self, SwigClassWrapper const * other) { - typedef ::Teuchos::RCP< ForTrilinos::NOXSolver > swig_lhs_classtype; + typedef Teuchos::RCP< ForTrilinos::NOXSolver > swig_lhs_classtype; SWIG_assign(swig_lhs_classtype, self, swig_lhs_classtype, const_cast(other), 0 | swig::IS_DESTR | swig::IS_COPY_CONSTR); diff --git a/src/interface/src/nox.i b/src/interface/src/nox.i index 7b581381..5521c208 100644 --- a/src/interface/src/nox.i +++ b/src/interface/src/nox.i @@ -89,17 +89,17 @@ SwigClassWrapper swigd_ForModelEvaluator_create_operator( Teuchos::RCP tempthis( const_cast(this) SWIG_NO_NULL_DELETER_0); SwigClassWrapper self; - self.ptr = &tempthis; + self.cptr = &tempthis; self.mem = SWIG_CREF; // since this function is const /* convert x -> class wrapper */ SwigClassWrapper farg1; - farg1.ptr = const_cast*>(&x); + farg1.cptr = const_cast*>(&x); farg1.mem = SWIG_CREF; // x is const /* convert f -> class wrapper */ SwigClassWrapper farg2; - farg2.ptr = &f; + farg2.cptr = &f; farg2.mem = SWIG_REF; // f is mutable swigd_ForModelEvaluator_evaluate_residual(&self, &farg1, &farg2); @@ -111,17 +111,17 @@ SwigClassWrapper swigd_ForModelEvaluator_create_operator( Teuchos::RCP tempthis( const_cast(this) SWIG_NO_NULL_DELETER_0); SwigClassWrapper self; - self.ptr = &tempthis; + self.cptr = &tempthis; self.mem = SWIG_CREF; // since this function is const /* convert x -> class wrapper */ SwigClassWrapper farg1; - farg1.ptr = const_cast*>(&x); + farg1.cptr = const_cast*>(&x); farg1.mem = SWIG_CREF; // x is const /* convert J -> class wrapper */ SwigClassWrapper farg2; - farg2.ptr = &J; + farg2.cptr = &J; farg2.mem = SWIG_REF; // f is mutable swigd_ForModelEvaluator_evaluate_jacobian(&self, &farg1, &farg2); @@ -133,17 +133,17 @@ SwigClassWrapper swigd_ForModelEvaluator_create_operator( Teuchos::RCP tempthis( const_cast(this) SWIG_NO_NULL_DELETER_0); SwigClassWrapper self; - self.ptr = &tempthis; + self.cptr = &tempthis; self.mem = SWIG_CREF; // since this function is const /* convert x -> class wrapper */ SwigClassWrapper farg1; - farg1.ptr = const_cast*>(&x); + farg1.cptr = const_cast*>(&x); farg1.mem = SWIG_CREF; // x is const /* convert M -> class wrapper */ SwigClassWrapper farg2; - farg2.ptr = &M; + farg2.cptr = &M; farg2.mem = SWIG_REF; // f is mutable swigd_ForModelEvaluator_evaluate_preconditioner(&self, &farg1, &farg2); @@ -154,12 +154,12 @@ SwigClassWrapper swigd_ForModelEvaluator_create_operator( Teuchos::RCP tempthis( const_cast(this) SWIG_NO_NULL_DELETER_0); SwigClassWrapper self; - self.ptr = &tempthis; + self.cptr = &tempthis; self.mem = SWIG_CREF; // since this function is const SwigClassWrapper fresult = swigd_ForModelEvaluator_get_x_map(&self); - Teuchos::RCP* smartresult = static_cast< Teuchos::RCP* >(fresult.ptr); + Teuchos::RCP* smartresult = static_cast< Teuchos::RCP* >(fresult.cptr); return *smartresult; } @@ -168,12 +168,12 @@ SwigClassWrapper swigd_ForModelEvaluator_create_operator( Teuchos::RCP tempthis( const_cast(this) SWIG_NO_NULL_DELETER_0); SwigClassWrapper self; - self.ptr = &tempthis; + self.cptr = &tempthis; self.mem = SWIG_CREF; // since this function is const SwigClassWrapper fresult = swigd_ForModelEvaluator_get_f_map(&self); - Teuchos::RCP* smartresult = static_cast< Teuchos::RCP* >(fresult.ptr); + Teuchos::RCP* smartresult = static_cast< Teuchos::RCP* >(fresult.cptr); return *smartresult; } @@ -182,29 +182,29 @@ SwigClassWrapper swigd_ForModelEvaluator_create_operator( Teuchos::RCP tempthis( const_cast(this) SWIG_NO_NULL_DELETER_0); SwigClassWrapper self; - self.ptr = &tempthis; + self.cptr = &tempthis; self.mem = SWIG_CREF; // since this function is const SwigClassWrapper fresult = swigd_ForModelEvaluator_create_operator(&self); - Teuchos::RCP* smartresult = static_cast< Teuchos::RCP* >(fresult.ptr); + Teuchos::RCP* smartresult = static_cast< Teuchos::RCP* >(fresult.cptr); return *smartresult; } }; #undef SWIG_NO_NULL_DELETER_0 %} -%insert("ftypes") %{ +%insert("fdecl") %{ type :: ForModelEvaluatorHandle class(ForModelEvaluator), pointer :: data end type %} -%insert("fpublic") %{ +%insert("fdecl") %{ public :: init_ForModelEvaluator %} -%insert("fwrapper") %{ +%insert("fsubprograms") %{ ! Convert a ISO-C class pointer struct into a user Fortran native pointer subroutine c_f_pointer_ForModelEvaluator(clswrap, fptr) type(SwigClassWrapper), intent(in) :: clswrap diff --git a/src/teuchos/src/forteuchos.f90 b/src/teuchos/src/forteuchos.f90 index bbf038a0..8e5a3b43 100644 --- a/src/teuchos/src/forteuchos.f90 +++ b/src/teuchos/src/forteuchos.f90 @@ -15,83 +15,70 @@ module forteuchos implicit none private - ! PUBLIC METHODS AND TYPES - public :: TeuchosESide, TeuchosLEFT_SIDE, TeuchosRIGHT_SIDE - public :: TeuchosETransp, TeuchosNO_TRANS, TeuchosTRANS, TeuchosCONJ_TRANS - public :: TeuchosEUplo, TeuchosUPPER_TRI, TeuchosLOWER_TRI, TeuchosUNDEF_TRI - public :: TeuchosEDiag, TeuchosUNIT_DIAG, TeuchosNON_UNIT_DIAG - public :: TeuchosEType, TeuchosFULL, TeuchosLOWER, TeuchosUPPER, TeuchosHESSENBERG, TeuchosSYM_BAND_L, TeuchosSYM_BAND_U, & - TeuchosBAND - public :: TeuchosDataAccess, TeuchosCopy, TeuchosView - public :: TeuchosComm - + ! DECLARATION CONSTRUCTS + ! enum Teuchos::ESide enum, bind(c) - enumerator :: SwigMemState = -1 - enumerator :: SWIG_NULL = 0 - enumerator :: SWIG_OWN - enumerator :: SWIG_MOVE - enumerator :: SWIG_REF - enumerator :: SWIG_CREF + enumerator :: TeuchosLEFT_SIDE + enumerator :: TeuchosRIGHT_SIDE end enum - - -type, bind(C) :: SwigClassWrapper - type(C_PTR), public :: ptr = C_NULL_PTR - integer(C_INT), public :: mem = SWIG_NULL -end type - - public :: ParameterList - -type, bind(C) :: SwigArrayWrapper - type(C_PTR), public :: data = C_NULL_PTR - integer(C_SIZE_T), public :: size = 0 -end type - - public :: load_from_xml - public :: save_to_xml - - ! PARAMETERS + integer, parameter, public :: TeuchosESide = kind(TeuchosLEFT_SIDE) + public :: TeuchosLEFT_SIDE, TeuchosRIGHT_SIDE + ! enum Teuchos::ETransp enum, bind(c) - enumerator :: TeuchosESide = -1 - enumerator :: TeuchosLEFT_SIDE = 0 - enumerator :: TeuchosRIGHT_SIDE = TeuchosLEFT_SIDE + 1 + enumerator :: TeuchosNO_TRANS + enumerator :: TeuchosTRANS + enumerator :: TeuchosCONJ_TRANS end enum + integer, parameter, public :: TeuchosETransp = kind(TeuchosNO_TRANS) + public :: TeuchosNO_TRANS, TeuchosTRANS, TeuchosCONJ_TRANS + ! enum Teuchos::EUplo enum, bind(c) - enumerator :: TeuchosETransp = -1 - enumerator :: TeuchosNO_TRANS = 0 - enumerator :: TeuchosTRANS = TeuchosNO_TRANS + 1 - enumerator :: TeuchosCONJ_TRANS = TeuchosTRANS + 1 + enumerator :: TeuchosUPPER_TRI + enumerator :: TeuchosLOWER_TRI + enumerator :: TeuchosUNDEF_TRI end enum + integer, parameter, public :: TeuchosEUplo = kind(TeuchosUPPER_TRI) + public :: TeuchosUPPER_TRI, TeuchosLOWER_TRI, TeuchosUNDEF_TRI + ! enum Teuchos::EDiag enum, bind(c) - enumerator :: TeuchosEUplo = -1 - enumerator :: TeuchosUPPER_TRI = 0 - enumerator :: TeuchosLOWER_TRI = TeuchosUPPER_TRI + 1 - enumerator :: TeuchosUNDEF_TRI = TeuchosLOWER_TRI + 1 + enumerator :: TeuchosUNIT_DIAG + enumerator :: TeuchosNON_UNIT_DIAG end enum + integer, parameter, public :: TeuchosEDiag = kind(TeuchosUNIT_DIAG) + public :: TeuchosUNIT_DIAG, TeuchosNON_UNIT_DIAG + ! enum Teuchos::EType enum, bind(c) - enumerator :: TeuchosEDiag = -1 - enumerator :: TeuchosUNIT_DIAG = 0 - enumerator :: TeuchosNON_UNIT_DIAG = TeuchosUNIT_DIAG + 1 + enumerator :: TeuchosFULL + enumerator :: TeuchosLOWER + enumerator :: TeuchosUPPER + enumerator :: TeuchosHESSENBERG + enumerator :: TeuchosSYM_BAND_L + enumerator :: TeuchosSYM_BAND_U + enumerator :: TeuchosBAND end enum + integer, parameter, public :: TeuchosEType = kind(TeuchosFULL) + public :: TeuchosFULL, TeuchosLOWER, TeuchosUPPER, TeuchosHESSENBERG, TeuchosSYM_BAND_L, TeuchosSYM_BAND_U, TeuchosBAND + ! enum Teuchos::DataAccess enum, bind(c) - enumerator :: TeuchosEType = -1 - enumerator :: TeuchosFULL = 0 - enumerator :: TeuchosLOWER = TeuchosFULL + 1 - enumerator :: TeuchosUPPER = TeuchosLOWER + 1 - enumerator :: TeuchosHESSENBERG = TeuchosUPPER + 1 - enumerator :: TeuchosSYM_BAND_L = TeuchosHESSENBERG + 1 - enumerator :: TeuchosSYM_BAND_U = TeuchosSYM_BAND_L + 1 - enumerator :: TeuchosBAND = TeuchosSYM_BAND_U + 1 + enumerator :: TeuchosCopy + enumerator :: TeuchosView end enum + integer, parameter, public :: TeuchosDataAccess = kind(TeuchosCopy) + public :: TeuchosCopy, TeuchosView enum, bind(c) - enumerator :: TeuchosDataAccess = -1 - enumerator :: TeuchosCopy = 0 - enumerator :: TeuchosView = TeuchosCopy + 1 + enumerator :: SWIG_NULL + enumerator :: SWIG_OWN + enumerator :: SWIG_MOVE + enumerator :: SWIG_REF + enumerator :: SWIG_CREF end enum - - ! TYPES - type :: TeuchosComm - ! These should be treated as PROTECTED data + integer, parameter :: SwigMemState = kind(SWIG_NULL) + type, bind(C) :: SwigClassWrapper + type(C_PTR), public :: cptr = C_NULL_PTR + integer(C_INT), public :: mem = SWIG_NULL + end type + ! class Teuchos::Comm< int > + type, public :: TeuchosComm type(SwigClassWrapper), public :: swigdata contains procedure :: getRank => swigf_TeuchosComm_getRank @@ -103,11 +90,15 @@ module forteuchos generic :: assignment(=) => swigf_assignment_TeuchosComm end type TeuchosComm interface TeuchosComm - procedure new_TeuchosComm__SWIG_0 - procedure new_TeuchosComm__SWIG_1 + module procedure new_TeuchosComm__SWIG_0 + module procedure new_TeuchosComm__SWIG_1 end interface - type :: ParameterList - ! These should be treated as PROTECTED data + type, bind(C) :: SwigArrayWrapper + type(C_PTR), public :: data = C_NULL_PTR + integer(C_SIZE_T), public :: size = 0 + end type + ! class Teuchos::ParameterList + type, public :: ParameterList type(SwigClassWrapper), public :: swigdata contains procedure :: print => swigf_ParameterList_print @@ -138,18 +129,19 @@ module forteuchos set__SWIG_9 end type ParameterList interface ParameterList - procedure new_ParameterList__SWIG_0 - procedure new_ParameterList__SWIG_1 + module procedure new_ParameterList__SWIG_0 + module procedure new_ParameterList__SWIG_1 end interface + public :: load_from_xml + public :: save_to_xml - - ! WRAPPER DECLARATIONS - interface +! WRAPPER DECLARATIONS +interface function swigc_TeuchosComm_getRank(farg1) & bind(C, name="_wrap_TeuchosComm_getRank") & result(fresult) use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 integer(C_INT) :: fresult end function @@ -158,7 +150,7 @@ function swigc_TeuchosComm_getSize(farg1) & bind(C, name="_wrap_TeuchosComm_getSize") & result(fresult) use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 integer(C_INT) :: fresult end function @@ -166,7 +158,7 @@ function swigc_TeuchosComm_getSize(farg1) & subroutine swigc_TeuchosComm_barrier(farg1) & bind(C, name="_wrap_TeuchosComm_barrier") use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 end subroutine @@ -174,7 +166,7 @@ function swigc_new_TeuchosComm__SWIG_0(farg1) & bind(C, name="_wrap_new_TeuchosComm__SWIG_0") & result(fresult) use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper integer(C_INT), intent(in) :: farg1 type(SwigClassWrapper) :: fresult end function @@ -183,7 +175,7 @@ function swigc_new_TeuchosComm__SWIG_1() & bind(C, name="_wrap_new_TeuchosComm__SWIG_1") & result(fresult) use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: fresult end function @@ -191,7 +183,7 @@ function swigc_TeuchosComm_getRawMpiComm(farg1) & bind(C, name="_wrap_TeuchosComm_getRawMpiComm") & result(fresult) use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 integer(C_INT) :: fresult end function @@ -199,7 +191,7 @@ function swigc_TeuchosComm_getRawMpiComm(farg1) & subroutine swigc_delete_TeuchosComm(farg1) & bind(C, name="_wrap_delete_TeuchosComm") use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 end subroutine @@ -214,7 +206,7 @@ function swigc_new_ParameterList__SWIG_0() & bind(C, name="_wrap_new_ParameterList__SWIG_0") & result(fresult) use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: fresult end function @@ -222,8 +214,8 @@ function swigc_new_ParameterList__SWIG_1(farg1) & bind(C, name="_wrap_new_ParameterList__SWIG_1") & result(fresult) use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper -import :: SwigArrayWrapper +import :: swigclasswrapper +import :: swigarraywrapper type(SwigArrayWrapper) :: farg1 type(SwigClassWrapper) :: fresult end function @@ -231,15 +223,15 @@ function swigc_new_ParameterList__SWIG_1(farg1) & subroutine swigc_ParameterList_print(farg1) & bind(C, name="_wrap_ParameterList_print") use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 end subroutine subroutine swigc_ParameterList_remove(farg1, farg2) & bind(C, name="_wrap_ParameterList_remove") use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper -import :: SwigArrayWrapper +import :: swigclasswrapper +import :: swigarraywrapper type(SwigClassWrapper) :: farg1 type(SwigArrayWrapper) :: farg2 end subroutine @@ -248,8 +240,8 @@ function swigc_ParameterList_is_parameter(farg1, farg2) & bind(C, name="_wrap_ParameterList_is_parameter") & result(fresult) use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper -import :: SwigArrayWrapper +import :: swigclasswrapper +import :: swigarraywrapper type(SwigClassWrapper) :: farg1 type(SwigArrayWrapper) :: farg2 logical(C_BOOL) :: fresult @@ -259,8 +251,8 @@ function swigc_ParameterList_sublist(farg1, farg2) & bind(C, name="_wrap_ParameterList_sublist") & result(fresult) use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper -import :: SwigArrayWrapper +import :: swigclasswrapper +import :: swigarraywrapper type(SwigClassWrapper) :: farg1 type(SwigArrayWrapper) :: farg2 type(SwigClassWrapper) :: fresult @@ -269,8 +261,8 @@ function swigc_ParameterList_sublist(farg1, farg2) & subroutine swigc_ParameterList_set__SWIG_1(farg1, farg2, farg3) & bind(C, name="_wrap_ParameterList_set__SWIG_1") use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper -import :: SwigArrayWrapper +import :: swigclasswrapper +import :: swigarraywrapper type(SwigClassWrapper) :: farg1 type(SwigArrayWrapper) :: farg2 real(C_DOUBLE), intent(in) :: farg3 @@ -279,8 +271,8 @@ subroutine swigc_ParameterList_set__SWIG_1(farg1, farg2, farg3) & subroutine swigc_ParameterList_set__SWIG_2(farg1, farg2, farg3) & bind(C, name="_wrap_ParameterList_set__SWIG_2") use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper -import :: SwigArrayWrapper +import :: swigclasswrapper +import :: swigarraywrapper type(SwigClassWrapper) :: farg1 type(SwigArrayWrapper) :: farg2 integer(C_INT), intent(in) :: farg3 @@ -289,8 +281,8 @@ subroutine swigc_ParameterList_set__SWIG_2(farg1, farg2, farg3) & subroutine swigc_ParameterList_set__SWIG_3(farg1, farg2, farg3) & bind(C, name="_wrap_ParameterList_set__SWIG_3") use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper -import :: SwigArrayWrapper +import :: swigclasswrapper +import :: swigarraywrapper type(SwigClassWrapper) :: farg1 type(SwigArrayWrapper) :: farg2 integer(C_LONG_LONG), intent(in) :: farg3 @@ -299,8 +291,8 @@ subroutine swigc_ParameterList_set__SWIG_3(farg1, farg2, farg3) & subroutine swigc_ParameterList_set__SWIG_4(farg1, farg2, farg3) & bind(C, name="_wrap_ParameterList_set__SWIG_4") use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper -import :: SwigArrayWrapper +import :: swigclasswrapper +import :: swigarraywrapper type(SwigClassWrapper) :: farg1 type(SwigArrayWrapper) :: farg2 logical(C_BOOL), intent(in) :: farg3 @@ -309,8 +301,8 @@ subroutine swigc_ParameterList_set__SWIG_4(farg1, farg2, farg3) & subroutine swigc_ParameterList_set__SWIG_5(farg1, farg2, farg3) & bind(C, name="_wrap_ParameterList_set__SWIG_5") use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper -import :: SwigArrayWrapper +import :: swigclasswrapper +import :: swigarraywrapper type(SwigClassWrapper) :: farg1 type(SwigArrayWrapper) :: farg2 type(SwigArrayWrapper) :: farg3 @@ -319,8 +311,8 @@ subroutine swigc_ParameterList_set__SWIG_5(farg1, farg2, farg3) & subroutine swigc_ParameterList_set__SWIG_6(farg1, farg2, farg3) & bind(C, name="_wrap_ParameterList_set__SWIG_6") use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper -import :: SwigArrayWrapper +import :: swigclasswrapper +import :: swigarraywrapper type(SwigClassWrapper) :: farg1 type(SwigArrayWrapper) :: farg2 type(SwigArrayWrapper) :: farg3 @@ -329,8 +321,8 @@ subroutine swigc_ParameterList_set__SWIG_6(farg1, farg2, farg3) & subroutine swigc_ParameterList_set__SWIG_7(farg1, farg2, farg3) & bind(C, name="_wrap_ParameterList_set__SWIG_7") use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper -import :: SwigArrayWrapper +import :: swigclasswrapper +import :: swigarraywrapper type(SwigClassWrapper) :: farg1 type(SwigArrayWrapper) :: farg2 type(SwigArrayWrapper) :: farg3 @@ -339,8 +331,8 @@ subroutine swigc_ParameterList_set__SWIG_7(farg1, farg2, farg3) & subroutine swigc_ParameterList_set__SWIG_8(farg1, farg2, farg3) & bind(C, name="_wrap_ParameterList_set__SWIG_8") use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper -import :: SwigArrayWrapper +import :: swigclasswrapper +import :: swigarraywrapper type(SwigClassWrapper) :: farg1 type(SwigArrayWrapper) :: farg2 type(SwigArrayWrapper) :: farg3 @@ -349,8 +341,8 @@ subroutine swigc_ParameterList_set__SWIG_8(farg1, farg2, farg3) & subroutine swigc_ParameterList_set__SWIG_9(farg1, farg2, farg3) & bind(C, name="_wrap_ParameterList_set__SWIG_9") use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper -import :: SwigArrayWrapper +import :: swigclasswrapper +import :: swigarraywrapper type(SwigClassWrapper) :: farg1 type(SwigArrayWrapper) :: farg2 type(SwigClassWrapper) :: farg3 @@ -360,8 +352,8 @@ function swigc_ParameterList_get_real(farg1, farg2) & bind(C, name="_wrap_ParameterList_get_real") & result(fresult) use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper -import :: SwigArrayWrapper +import :: swigclasswrapper +import :: swigarraywrapper type(SwigClassWrapper) :: farg1 type(SwigArrayWrapper) :: farg2 real(C_DOUBLE) :: fresult @@ -371,8 +363,8 @@ function swigc_ParameterList_get_integer(farg1, farg2) & bind(C, name="_wrap_ParameterList_get_integer") & result(fresult) use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper -import :: SwigArrayWrapper +import :: swigclasswrapper +import :: swigarraywrapper type(SwigClassWrapper) :: farg1 type(SwigArrayWrapper) :: farg2 integer(C_INT) :: fresult @@ -382,8 +374,8 @@ function swigc_ParameterList_get_longlong(farg1, farg2) & bind(C, name="_wrap_ParameterList_get_longlong") & result(fresult) use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper -import :: SwigArrayWrapper +import :: swigclasswrapper +import :: swigarraywrapper type(SwigClassWrapper) :: farg1 type(SwigArrayWrapper) :: farg2 integer(C_LONG_LONG) :: fresult @@ -393,8 +385,8 @@ function swigc_ParameterList_get_logical(farg1, farg2) & bind(C, name="_wrap_ParameterList_get_logical") & result(fresult) use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper -import :: SwigArrayWrapper +import :: swigclasswrapper +import :: swigarraywrapper type(SwigClassWrapper) :: farg1 type(SwigArrayWrapper) :: farg2 logical(C_BOOL) :: fresult @@ -404,8 +396,8 @@ function swigc_ParameterList_get_string(farg1, farg2) & bind(C, name="_wrap_ParameterList_get_string") & result(fresult) use, intrinsic :: ISO_C_BINDING -import :: SwigArrayWrapper -import :: SwigClassWrapper +import :: swigarraywrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 type(SwigArrayWrapper) :: farg2 type(SwigArrayWrapper) :: fresult @@ -415,8 +407,8 @@ function swigc_ParameterList_get_arr_real(farg1, farg2) & bind(C, name="_wrap_ParameterList_get_arr_real") & result(fresult) use, intrinsic :: ISO_C_BINDING -import :: SwigArrayWrapper -import :: SwigClassWrapper +import :: swigarraywrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 type(SwigArrayWrapper) :: farg2 type(SwigArrayWrapper) :: fresult @@ -426,8 +418,8 @@ function swigc_ParameterList_get_arr_integer(farg1, farg2) & bind(C, name="_wrap_ParameterList_get_arr_integer") & result(fresult) use, intrinsic :: ISO_C_BINDING -import :: SwigArrayWrapper -import :: SwigClassWrapper +import :: swigarraywrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 type(SwigArrayWrapper) :: farg2 type(SwigArrayWrapper) :: fresult @@ -437,8 +429,8 @@ function swigc_ParameterList_get_arr_longlong(farg1, farg2) & bind(C, name="_wrap_ParameterList_get_arr_longlong") & result(fresult) use, intrinsic :: ISO_C_BINDING -import :: SwigArrayWrapper -import :: SwigClassWrapper +import :: swigarraywrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 type(SwigArrayWrapper) :: farg2 type(SwigArrayWrapper) :: fresult @@ -447,7 +439,7 @@ function swigc_ParameterList_get_arr_longlong(farg1, farg2) & subroutine swigc_delete_ParameterList(farg1) & bind(C, name="_wrap_delete_ParameterList") use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 end subroutine @@ -461,8 +453,8 @@ subroutine swigc_assignment_ParameterList(self, other) & subroutine swigc_load_from_xml(farg1, farg2) & bind(C, name="_wrap_load_from_xml") use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper -import :: SwigArrayWrapper +import :: swigclasswrapper +import :: swigarraywrapper type(SwigClassWrapper) :: farg1 type(SwigArrayWrapper) :: farg2 end subroutine @@ -470,22 +462,23 @@ subroutine swigc_load_from_xml(farg1, farg2) & subroutine swigc_save_to_xml(farg1, farg2) & bind(C, name="_wrap_save_to_xml") use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper -import :: SwigArrayWrapper +import :: swigclasswrapper +import :: swigarraywrapper type(SwigClassWrapper) :: farg1 type(SwigArrayWrapper) :: farg2 end subroutine - end interface +end interface contains - ! FORTRAN PROXY CODE + ! MODULE SUBPROGRAMS function swigf_TeuchosComm_getRank(self) & result(swig_result) use, intrinsic :: ISO_C_BINDING integer(C_INT) :: swig_result class(TeuchosComm), intent(in) :: self + integer(C_INT) :: fresult type(SwigClassWrapper) :: farg1 @@ -499,6 +492,7 @@ function swigf_TeuchosComm_getSize(self) & use, intrinsic :: ISO_C_BINDING integer(C_INT) :: swig_result class(TeuchosComm), intent(in) :: self + integer(C_INT) :: fresult type(SwigClassWrapper) :: farg1 @@ -510,6 +504,7 @@ function swigf_TeuchosComm_getSize(self) & subroutine swigf_TeuchosComm_barrier(self) use, intrinsic :: ISO_C_BINDING class(TeuchosComm), intent(in) :: self + type(SwigClassWrapper) :: farg1 farg1 = self%swigdata @@ -521,6 +516,7 @@ function new_TeuchosComm__SWIG_0(rawmpicomm) & use, intrinsic :: ISO_C_BINDING type(TeuchosComm) :: self integer :: rawmpicomm + type(SwigClassWrapper) :: fresult integer(C_INT) :: farg1 @@ -533,6 +529,7 @@ function new_TeuchosComm__SWIG_1() & result(self) use, intrinsic :: ISO_C_BINDING type(TeuchosComm) :: self + type(SwigClassWrapper) :: fresult fresult = swigc_new_TeuchosComm__SWIG_1() @@ -544,6 +541,7 @@ function swigf_TeuchosComm_getRawMpiComm(self) & use, intrinsic :: ISO_C_BINDING integer :: swig_result class(TeuchosComm), intent(inout) :: self + integer(C_INT) :: fresult type(SwigClassWrapper) :: farg1 @@ -555,13 +553,14 @@ function swigf_TeuchosComm_getRawMpiComm(self) & subroutine delete_TeuchosComm(self) use, intrinsic :: ISO_C_BINDING class(TeuchosComm), intent(inout) :: self + type(SwigClassWrapper) :: farg1 farg1 = self%swigdata if (self%swigdata%mem == SWIG_OWN) then call swigc_delete_TeuchosComm(farg1) end if -self%swigdata%ptr = C_NULL_PTR +self%swigdata%cptr = C_NULL_PTR self%swigdata%mem = SWIG_NULL end subroutine @@ -575,6 +574,7 @@ function new_ParameterList__SWIG_0() & result(self) use, intrinsic :: ISO_C_BINDING type(ParameterList) :: self + type(SwigClassWrapper) :: fresult fresult = swigc_new_ParameterList__SWIG_0() @@ -605,6 +605,7 @@ function new_ParameterList__SWIG_1(name) & type(ParameterList) :: self character(kind=C_CHAR, len=*), target :: name character(kind=C_CHAR), dimension(:), allocatable, target :: farg1_chars + type(SwigClassWrapper) :: fresult type(SwigArrayWrapper) :: farg1 @@ -616,6 +617,7 @@ function new_ParameterList__SWIG_1(name) & subroutine swigf_ParameterList_print(self) use, intrinsic :: ISO_C_BINDING class(ParameterList), intent(in) :: self + type(SwigClassWrapper) :: farg1 farg1 = self%swigdata @@ -625,8 +627,10 @@ subroutine swigf_ParameterList_print(self) subroutine swigf_ParameterList_remove(self, name) use, intrinsic :: ISO_C_BINDING class(ParameterList), intent(inout) :: self + character(kind=C_CHAR, len=*), target :: name character(kind=C_CHAR), dimension(:), allocatable, target :: farg2_chars + type(SwigClassWrapper) :: farg1 type(SwigArrayWrapper) :: farg2 @@ -640,8 +644,10 @@ function swigf_ParameterList_is_parameter(self, name) & use, intrinsic :: ISO_C_BINDING logical(C_BOOL) :: swig_result class(ParameterList), intent(in) :: self + character(kind=C_CHAR, len=*), target :: name character(kind=C_CHAR), dimension(:), allocatable, target :: farg2_chars + logical(C_BOOL) :: fresult type(SwigClassWrapper) :: farg1 type(SwigArrayWrapper) :: farg2 @@ -657,8 +663,10 @@ function swigf_ParameterList_sublist(self, name) & use, intrinsic :: ISO_C_BINDING type(ParameterList) :: swig_result class(ParameterList), intent(inout) :: self + character(kind=C_CHAR, len=*), target :: name character(kind=C_CHAR), dimension(:), allocatable, target :: farg2_chars + type(SwigClassWrapper) :: fresult type(SwigClassWrapper) :: farg1 type(SwigArrayWrapper) :: farg2 @@ -672,9 +680,11 @@ function swigf_ParameterList_sublist(self, name) & subroutine swigf_ParameterList_set__SWIG_1(self, name, value) use, intrinsic :: ISO_C_BINDING class(ParameterList), intent(inout) :: self + character(kind=C_CHAR, len=*), target :: name character(kind=C_CHAR), dimension(:), allocatable, target :: farg2_chars real(C_DOUBLE), intent(in) :: value + type(SwigClassWrapper) :: farg1 type(SwigArrayWrapper) :: farg2 real(C_DOUBLE) :: farg3 @@ -688,9 +698,11 @@ subroutine swigf_ParameterList_set__SWIG_1(self, name, value) subroutine swigf_ParameterList_set__SWIG_2(self, name, value) use, intrinsic :: ISO_C_BINDING class(ParameterList), intent(inout) :: self + character(kind=C_CHAR, len=*), target :: name character(kind=C_CHAR), dimension(:), allocatable, target :: farg2_chars integer(C_INT), intent(in) :: value + type(SwigClassWrapper) :: farg1 type(SwigArrayWrapper) :: farg2 integer(C_INT) :: farg3 @@ -704,9 +716,11 @@ subroutine swigf_ParameterList_set__SWIG_2(self, name, value) subroutine swigf_ParameterList_set__SWIG_3(self, name, value) use, intrinsic :: ISO_C_BINDING class(ParameterList), intent(inout) :: self + character(kind=C_CHAR, len=*), target :: name character(kind=C_CHAR), dimension(:), allocatable, target :: farg2_chars integer(C_LONG_LONG), intent(in) :: value + type(SwigClassWrapper) :: farg1 type(SwigArrayWrapper) :: farg2 integer(C_LONG_LONG) :: farg3 @@ -720,9 +734,11 @@ subroutine swigf_ParameterList_set__SWIG_3(self, name, value) subroutine swigf_ParameterList_set__SWIG_4(self, name, value) use, intrinsic :: ISO_C_BINDING class(ParameterList), intent(inout) :: self + character(kind=C_CHAR, len=*), target :: name character(kind=C_CHAR), dimension(:), allocatable, target :: farg2_chars logical(C_BOOL), intent(in) :: value + type(SwigClassWrapper) :: farg1 type(SwigArrayWrapper) :: farg2 logical(C_BOOL) :: farg3 @@ -736,10 +752,12 @@ subroutine swigf_ParameterList_set__SWIG_4(self, name, value) subroutine swigf_ParameterList_set__SWIG_5(self, name, value) use, intrinsic :: ISO_C_BINDING class(ParameterList), intent(inout) :: self + character(kind=C_CHAR, len=*), target :: name character(kind=C_CHAR), dimension(:), allocatable, target :: farg2_chars character(kind=C_CHAR, len=*), target :: value character(kind=C_CHAR), dimension(:), allocatable, target :: farg3_chars + type(SwigClassWrapper) :: farg1 type(SwigArrayWrapper) :: farg2 type(SwigArrayWrapper) :: farg3 @@ -753,10 +771,12 @@ subroutine swigf_ParameterList_set__SWIG_5(self, name, value) subroutine swigf_ParameterList_set__SWIG_6(self, name, value) use, intrinsic :: ISO_C_BINDING class(ParameterList), intent(inout) :: self + character(kind=C_CHAR, len=*), target :: name character(kind=C_CHAR), dimension(:), allocatable, target :: farg2_chars -real(C_DOUBLE), dimension(:), target, intent(in) :: value +real(C_DOUBLE), dimension(:), target :: value real(C_DOUBLE), pointer :: farg3_view + type(SwigClassWrapper) :: farg1 type(SwigArrayWrapper) :: farg2 type(SwigArrayWrapper) :: farg3 @@ -772,10 +792,12 @@ subroutine swigf_ParameterList_set__SWIG_6(self, name, value) subroutine swigf_ParameterList_set__SWIG_7(self, name, value) use, intrinsic :: ISO_C_BINDING class(ParameterList), intent(inout) :: self + character(kind=C_CHAR, len=*), target :: name character(kind=C_CHAR), dimension(:), allocatable, target :: farg2_chars -integer(C_INT), dimension(:), target, intent(in) :: value +integer(C_INT), dimension(:), target :: value integer(C_INT), pointer :: farg3_view + type(SwigClassWrapper) :: farg1 type(SwigArrayWrapper) :: farg2 type(SwigArrayWrapper) :: farg3 @@ -791,10 +813,12 @@ subroutine swigf_ParameterList_set__SWIG_7(self, name, value) subroutine swigf_ParameterList_set__SWIG_8(self, name, value) use, intrinsic :: ISO_C_BINDING class(ParameterList), intent(inout) :: self + character(kind=C_CHAR, len=*), target :: name character(kind=C_CHAR), dimension(:), allocatable, target :: farg2_chars -integer(C_LONG_LONG), dimension(:), target, intent(in) :: value +integer(C_LONG_LONG), dimension(:), target :: value integer(C_LONG_LONG), pointer :: farg3_view + type(SwigClassWrapper) :: farg1 type(SwigArrayWrapper) :: farg2 type(SwigArrayWrapper) :: farg3 @@ -810,9 +834,11 @@ subroutine swigf_ParameterList_set__SWIG_8(self, name, value) subroutine swigf_ParameterList_set__SWIG_9(self, name, value) use, intrinsic :: ISO_C_BINDING class(ParameterList), intent(inout) :: self + character(kind=C_CHAR, len=*), target :: name character(kind=C_CHAR), dimension(:), allocatable, target :: farg2_chars class(ParameterList), intent(in) :: value + type(SwigClassWrapper) :: farg1 type(SwigArrayWrapper) :: farg2 type(SwigClassWrapper) :: farg3 @@ -828,8 +854,10 @@ function swigf_ParameterList_get_real(self, name) & use, intrinsic :: ISO_C_BINDING real(C_DOUBLE) :: swig_result class(ParameterList), intent(inout) :: self + character(kind=C_CHAR, len=*), target :: name character(kind=C_CHAR), dimension(:), allocatable, target :: farg2_chars + real(C_DOUBLE) :: fresult type(SwigClassWrapper) :: farg1 type(SwigArrayWrapper) :: farg2 @@ -845,8 +873,10 @@ function swigf_ParameterList_get_integer(self, name) & use, intrinsic :: ISO_C_BINDING integer(C_INT) :: swig_result class(ParameterList), intent(inout) :: self + character(kind=C_CHAR, len=*), target :: name character(kind=C_CHAR), dimension(:), allocatable, target :: farg2_chars + integer(C_INT) :: fresult type(SwigClassWrapper) :: farg1 type(SwigArrayWrapper) :: farg2 @@ -862,8 +892,10 @@ function swigf_ParameterList_get_longlong(self, name) & use, intrinsic :: ISO_C_BINDING integer(C_LONG_LONG) :: swig_result class(ParameterList), intent(inout) :: self + character(kind=C_CHAR, len=*), target :: name character(kind=C_CHAR), dimension(:), allocatable, target :: farg2_chars + integer(C_LONG_LONG) :: fresult type(SwigClassWrapper) :: farg1 type(SwigArrayWrapper) :: farg2 @@ -879,8 +911,10 @@ function swigf_ParameterList_get_logical(self, name) & use, intrinsic :: ISO_C_BINDING logical(C_BOOL) :: swig_result class(ParameterList), intent(inout) :: self + character(kind=C_CHAR, len=*), target :: name character(kind=C_CHAR), dimension(:), allocatable, target :: farg2_chars + logical(C_BOOL) :: fresult type(SwigClassWrapper) :: farg1 type(SwigArrayWrapper) :: farg2 @@ -910,8 +944,10 @@ function swigf_ParameterList_get_string(self, name) & use, intrinsic :: ISO_C_BINDING character(kind=C_CHAR, len=:), allocatable :: swig_result class(ParameterList), intent(inout) :: self + character(kind=C_CHAR, len=*), target :: name character(kind=C_CHAR), dimension(:), allocatable, target :: farg2_chars + type(SwigArrayWrapper) :: fresult type(SwigClassWrapper) :: farg1 type(SwigArrayWrapper) :: farg2 @@ -925,11 +961,12 @@ function swigf_ParameterList_get_string(self, name) & function swigf_ParameterList_get_arr_real(self, name) & result(swig_result) use, intrinsic :: ISO_C_BINDING -real(C_DOUBLE), dimension(:), allocatable :: swig_result +real(C_DOUBLE), dimension(:), pointer :: swig_result class(ParameterList), intent(inout) :: self + character(kind=C_CHAR, len=*), target :: name character(kind=C_CHAR), dimension(:), allocatable, target :: farg2_chars -real(C_DOUBLE), pointer :: fresult_view(:) + type(SwigArrayWrapper) :: fresult type(SwigClassWrapper) :: farg1 type(SwigArrayWrapper) :: farg2 @@ -937,19 +974,18 @@ function swigf_ParameterList_get_arr_real(self, name) & farg1 = self%swigdata call SWIG_string_to_chararray(name, farg2_chars, farg2) fresult = swigc_ParameterList_get_arr_real(farg1, farg2) -call c_f_pointer(fresult%data, fresult_view, [fresult%size]) -allocate(real(C_DOUBLE) :: swig_result(size(fresult_view))) -swig_result = fresult_view +call c_f_pointer(fresult%data, swig_result, [fresult%size]) end function function swigf_ParameterList_get_arr_integer(self, name) & result(swig_result) use, intrinsic :: ISO_C_BINDING -integer(C_INT), dimension(:), allocatable :: swig_result +integer(C_INT), dimension(:), pointer :: swig_result class(ParameterList), intent(inout) :: self + character(kind=C_CHAR, len=*), target :: name character(kind=C_CHAR), dimension(:), allocatable, target :: farg2_chars -integer(C_INT), pointer :: fresult_view(:) + type(SwigArrayWrapper) :: fresult type(SwigClassWrapper) :: farg1 type(SwigArrayWrapper) :: farg2 @@ -957,19 +993,18 @@ function swigf_ParameterList_get_arr_integer(self, name) & farg1 = self%swigdata call SWIG_string_to_chararray(name, farg2_chars, farg2) fresult = swigc_ParameterList_get_arr_integer(farg1, farg2) -call c_f_pointer(fresult%data, fresult_view, [fresult%size]) -allocate(integer(C_INT) :: swig_result(size(fresult_view))) -swig_result = fresult_view +call c_f_pointer(fresult%data, swig_result, [fresult%size]) end function function swigf_ParameterList_get_arr_longlong(self, name) & result(swig_result) use, intrinsic :: ISO_C_BINDING -integer(C_LONG_LONG), dimension(:), allocatable :: swig_result +integer(C_LONG_LONG), dimension(:), pointer :: swig_result class(ParameterList), intent(inout) :: self + character(kind=C_CHAR, len=*), target :: name character(kind=C_CHAR), dimension(:), allocatable, target :: farg2_chars -integer(C_LONG_LONG), pointer :: fresult_view(:) + type(SwigArrayWrapper) :: fresult type(SwigClassWrapper) :: farg1 type(SwigArrayWrapper) :: farg2 @@ -977,21 +1012,20 @@ function swigf_ParameterList_get_arr_longlong(self, name) & farg1 = self%swigdata call SWIG_string_to_chararray(name, farg2_chars, farg2) fresult = swigc_ParameterList_get_arr_longlong(farg1, farg2) -call c_f_pointer(fresult%data, fresult_view, [fresult%size]) -allocate(integer(C_LONG_LONG) :: swig_result(size(fresult_view))) -swig_result = fresult_view +call c_f_pointer(fresult%data, swig_result, [fresult%size]) end function subroutine delete_ParameterList(self) use, intrinsic :: ISO_C_BINDING class(ParameterList), intent(inout) :: self + type(SwigClassWrapper) :: farg1 farg1 = self%swigdata if (self%swigdata%mem == SWIG_OWN) then call swigc_delete_ParameterList(farg1) end if -self%swigdata%ptr = C_NULL_PTR +self%swigdata%cptr = C_NULL_PTR self%swigdata%mem = SWIG_NULL end subroutine @@ -1004,8 +1038,10 @@ subroutine swigf_assignment_ParameterList(self, other) subroutine load_from_xml(plist, xml_path) use, intrinsic :: ISO_C_BINDING class(ParameterList), intent(in) :: plist + character(kind=C_CHAR, len=*), target :: xml_path character(kind=C_CHAR), dimension(:), allocatable, target :: farg2_chars + type(SwigClassWrapper) :: farg1 type(SwigArrayWrapper) :: farg2 @@ -1017,8 +1053,10 @@ subroutine load_from_xml(plist, xml_path) subroutine save_to_xml(plist, xml_path) use, intrinsic :: ISO_C_BINDING class(ParameterList), intent(in) :: plist + character(kind=C_CHAR, len=*), target :: xml_path character(kind=C_CHAR), dimension(:), allocatable, target :: farg2_chars + type(SwigClassWrapper) :: farg1 type(SwigArrayWrapper) :: farg2 diff --git a/src/teuchos/src/forteuchos.i b/src/teuchos/src/forteuchos.i index 3d0a2094..d75374c2 100644 --- a/src/teuchos/src/forteuchos.i +++ b/src/teuchos/src/forteuchos.i @@ -22,7 +22,7 @@ typedef int Teuchos_Ordinal; %fortran_view(size_t) // FIXME: Restore previous bool behaviour -FORT_FUND_TYPEMAP(bool, "logical(C_BOOL)") +FORT_FUND_TYPEMAP(bool, logical(C_BOOL)) // Convert all std::string references/values to and from Fortran strings %include diff --git a/src/teuchos/src/forteuchosFORTRAN_wrap.cxx b/src/teuchos/src/forteuchosFORTRAN_wrap.cxx index a3102257..0f545afe 100644 --- a/src/teuchos/src/forteuchosFORTRAN_wrap.cxx +++ b/src/teuchos/src/forteuchosFORTRAN_wrap.cxx @@ -191,7 +191,7 @@ template T SwigValueInit() { #define SWIG_exception_impl(DECL, CODE, MSG, RETURNNULL) \ - { throw std::logic_error("In " DECL ": " MSG); RETURNNULL; } + { throw std::logic_error("In " DECL ": " MSG); } extern "C" { @@ -293,7 +293,7 @@ struct assignment_flags, Flags> { enum SwigMemState { - SWIG_NULL = 0, + SWIG_NULL, SWIG_OWN, SWIG_MOVE, SWIG_REF, @@ -302,14 +302,14 @@ enum SwigMemState { struct SwigClassWrapper { - void* ptr; + void* cptr; SwigMemState mem; }; SWIGINTERN SwigClassWrapper SwigClassWrapper_uninitialized() { SwigClassWrapper result; - result.ptr = NULL; + result.cptr = NULL; result.mem = SWIG_NULL; return result; } @@ -477,27 +477,28 @@ struct AssignmentTraits { template SWIGINTERN void SWIG_assign_impl(SwigClassWrapper* self, SwigClassWrapper* other) { typedef swig::AssignmentTraits Traits_t; - T1* pself = static_cast(self->ptr); - T2* pother = static_cast(other->ptr); + T1* pself = static_cast(self->cptr); + T2* pother = static_cast(other->cptr); switch (self->mem) { case SWIG_NULL: /* LHS is unassigned */ switch (other->mem) { - case SWIG_NULL: /* null op */ break; + case SWIG_NULL: /* null op */ + break; case SWIG_MOVE: /* capture pointer from RHS */ - self->ptr = other->ptr; - other->ptr = NULL; + self->cptr = other->cptr; + other->cptr = NULL; self->mem = SWIG_OWN; other->mem = SWIG_NULL; break; case SWIG_OWN: /* copy from RHS */ - self->ptr = Traits_t::copy_construct(pother); + self->cptr = Traits_t::copy_construct(pother); self->mem = SWIG_OWN; break; case SWIG_REF: /* pointer to RHS */ case SWIG_CREF: - self->ptr = other->ptr; + self->cptr = other->cptr; self->mem = other->mem; break; } @@ -508,14 +509,14 @@ SWIGINTERN void SWIG_assign_impl(SwigClassWrapper* self, SwigClassWrapper* other case SWIG_NULL: /* Delete LHS */ Traits_t::destruct(pself); - self->ptr = NULL; + self->cptr = NULL; self->mem = SWIG_NULL; break; case SWIG_MOVE: /* Move RHS into LHS; delete RHS */ Traits_t::move_assign(pself, pother); Traits_t::destruct(pother); - other->ptr = NULL; + other->cptr = NULL; other->mem = SWIG_NULL; break; case SWIG_OWN: @@ -536,7 +537,7 @@ SWIGINTERN void SWIG_assign_impl(SwigClassWrapper* self, SwigClassWrapper* other switch (other->mem) { case SWIG_NULL: /* Remove LHS reference */ - self->ptr = NULL; + self->cptr = NULL; self->mem = SWIG_NULL; break; case SWIG_MOVE: @@ -544,7 +545,7 @@ SWIGINTERN void SWIG_assign_impl(SwigClassWrapper* self, SwigClassWrapper* other * same. */ Traits_t::move_assign(pself, pother); Traits_t::destruct(pother); - other->ptr = NULL; + other->cptr = NULL; other->mem = SWIG_NULL; break; case SWIG_OWN: @@ -559,8 +560,9 @@ SWIGINTERN void SWIG_assign_impl(SwigClassWrapper* self, SwigClassWrapper* other switch (other->mem) { case SWIG_NULL: /* Remove LHS reference */ - self->ptr = NULL; + self->cptr = NULL; self->mem = SWIG_NULL; + break; default: SWIG_exception_impl("assignment", SWIG_RuntimeError, "Cannot assign to a const reference", return); @@ -623,8 +625,8 @@ SWIGEXPORT int _wrap_TeuchosComm_getRank(SwigClassWrapper const *farg1) { Teuchos::RCP< Teuchos::Comm< int > const > *smartarg1 ; int result; - smartarg1 = static_cast< Teuchos::RCP >* >(farg1->ptr); - arg1 = smartarg1 ? const_cast*>(smartarg1->get()) : NULL; + smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Teuchos::Comm* >(smartarg1->get()) : NULL; { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Teuchos::Comm< int >::getRank() const");; @@ -648,7 +650,7 @@ SWIGEXPORT int _wrap_TeuchosComm_getRank(SwigClassWrapper const *farg1) { SWIG_exception_impl("Teuchos::Comm< int >::getRank() const", SWIG_UnknownError, "An unknown exception occurred", return 0); } } - fresult = result; + fresult = static_cast< int >(result); return fresult; } @@ -659,8 +661,8 @@ SWIGEXPORT int _wrap_TeuchosComm_getSize(SwigClassWrapper const *farg1) { Teuchos::RCP< Teuchos::Comm< int > const > *smartarg1 ; int result; - smartarg1 = static_cast< Teuchos::RCP >* >(farg1->ptr); - arg1 = smartarg1 ? const_cast*>(smartarg1->get()) : NULL; + smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Teuchos::Comm* >(smartarg1->get()) : NULL; { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Teuchos::Comm< int >::getSize() const");; @@ -684,7 +686,7 @@ SWIGEXPORT int _wrap_TeuchosComm_getSize(SwigClassWrapper const *farg1) { SWIG_exception_impl("Teuchos::Comm< int >::getSize() const", SWIG_UnknownError, "An unknown exception occurred", return 0); } } - fresult = result; + fresult = static_cast< int >(result); return fresult; } @@ -693,8 +695,8 @@ SWIGEXPORT void _wrap_TeuchosComm_barrier(SwigClassWrapper const *farg1) { Teuchos::Comm< int > *arg1 = (Teuchos::Comm< int > *) 0 ; Teuchos::RCP< Teuchos::Comm< int > const > *smartarg1 ; - smartarg1 = static_cast< Teuchos::RCP >* >(farg1->ptr); - arg1 = smartarg1 ? const_cast*>(smartarg1->get()) : NULL; + smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Teuchos::Comm* >(smartarg1->get()) : NULL; { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Teuchos::Comm< int >::barrier() const");; @@ -755,7 +757,7 @@ SWIGEXPORT SwigClassWrapper _wrap_new_TeuchosComm__SWIG_0(int const *farg1) { SWIG_exception_impl("Teuchos::Comm< int >::Comm(MPI_Comm)", SWIG_UnknownError, "An unknown exception occurred", return SwigClassWrapper_uninitialized()); } } - fresult.ptr = result ? new Teuchos::RCP< Teuchos::Comm >(result SWIG_NO_NULL_DELETER_1) : NULL; + fresult.cptr = result ? new Teuchos::RCP< Teuchos::Comm >(result SWIG_NO_NULL_DELETER_1) : NULL; fresult.mem = SWIG_MOVE; return fresult; } @@ -788,7 +790,7 @@ SWIGEXPORT SwigClassWrapper _wrap_new_TeuchosComm__SWIG_1() { SWIG_exception_impl("Teuchos::Comm< int >::Comm()", SWIG_UnknownError, "An unknown exception occurred", return SwigClassWrapper_uninitialized()); } } - fresult.ptr = result ? new Teuchos::RCP< Teuchos::Comm >(result SWIG_NO_NULL_DELETER_1) : NULL; + fresult.cptr = result ? new Teuchos::RCP< Teuchos::Comm >(result SWIG_NO_NULL_DELETER_1) : NULL; fresult.mem = SWIG_MOVE; return fresult; } @@ -800,8 +802,8 @@ SWIGEXPORT int _wrap_TeuchosComm_getRawMpiComm(SwigClassWrapper const *farg1) { Teuchos::RCP< Teuchos::Comm< int > > *smartarg1 ; MPI_Comm result; - smartarg1 = static_cast< Teuchos::RCP< Teuchos::Comm >* >(farg1->ptr); - arg1 = smartarg1 ? smartarg1->get() : NULL; + smartarg1 = static_cast< Teuchos::RCP< Teuchos::Comm >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Teuchos::Comm* >(smartarg1->get()) : NULL; { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Teuchos::Comm< int >::getRawMpiComm()");; @@ -838,8 +840,8 @@ SWIGEXPORT void _wrap_delete_TeuchosComm(SwigClassWrapper const *farg1) { Teuchos::Comm< int > *arg1 = (Teuchos::Comm< int > *) 0 ; Teuchos::RCP< Teuchos::Comm< int > > *smartarg1 ; - smartarg1 = static_cast< Teuchos::RCP< Teuchos::Comm >* >(farg1->ptr); - arg1 = smartarg1 ? smartarg1->get() : NULL; + smartarg1 = static_cast< Teuchos::RCP< Teuchos::Comm >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Teuchos::Comm* >(smartarg1->get()) : NULL; { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Teuchos::Comm< int >::~Comm()");; @@ -868,7 +870,7 @@ SWIGEXPORT void _wrap_delete_TeuchosComm(SwigClassWrapper const *farg1) { SWIGEXPORT void _wrap_assign_TeuchosComm(SwigClassWrapper * self, SwigClassWrapper const * other) { - typedef ::Teuchos::RCP< Teuchos::Comm > swig_lhs_classtype; + typedef Teuchos::RCP< Teuchos::Comm > swig_lhs_classtype; SWIG_assign(swig_lhs_classtype, self, swig_lhs_classtype, const_cast(other), 0 | swig::IS_DESTR | swig::IS_COPY_CONSTR); @@ -902,7 +904,7 @@ SWIGEXPORT SwigClassWrapper _wrap_new_ParameterList__SWIG_0() { SWIG_exception_impl("Teuchos::ParameterList::ParameterList()", SWIG_UnknownError, "An unknown exception occurred", return SwigClassWrapper_uninitialized()); } } - fresult.ptr = result ? new Teuchos::RCP< Teuchos::ParameterList >(result SWIG_NO_NULL_DELETER_1) : NULL; + fresult.cptr = result ? new Teuchos::RCP< Teuchos::ParameterList >(result SWIG_NO_NULL_DELETER_1) : NULL; fresult.mem = SWIG_MOVE; return fresult; } @@ -939,7 +941,7 @@ SWIGEXPORT SwigClassWrapper _wrap_new_ParameterList__SWIG_1(SwigArrayWrapper *fa SWIG_exception_impl("Teuchos::ParameterList::ParameterList(std::string const &)", SWIG_UnknownError, "An unknown exception occurred", return SwigClassWrapper_uninitialized()); } } - fresult.ptr = result ? new Teuchos::RCP< Teuchos::ParameterList >(result SWIG_NO_NULL_DELETER_1) : NULL; + fresult.cptr = result ? new Teuchos::RCP< Teuchos::ParameterList >(result SWIG_NO_NULL_DELETER_1) : NULL; fresult.mem = SWIG_MOVE; return fresult; } @@ -949,8 +951,8 @@ SWIGEXPORT void _wrap_ParameterList_print(SwigClassWrapper const *farg1) { Teuchos::ParameterList *arg1 = (Teuchos::ParameterList *) 0 ; Teuchos::RCP< Teuchos::ParameterList const > *smartarg1 ; - smartarg1 = static_cast< Teuchos::RCP* >(farg1->ptr); - arg1 = smartarg1 ? const_cast(smartarg1->get()) : NULL; + smartarg1 = static_cast< Teuchos::RCP* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Teuchos::ParameterList* >(smartarg1->get()) : NULL; { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Teuchos::ParameterList::print() const");; @@ -984,8 +986,8 @@ SWIGEXPORT void _wrap_ParameterList_remove(SwigClassWrapper const *farg1, SwigAr Teuchos::RCP< Teuchos::ParameterList > *smartarg1 ; std::string tempstr2 ; - smartarg1 = static_cast< Teuchos::RCP< Teuchos::ParameterList >* >(farg1->ptr); - arg1 = smartarg1 ? smartarg1->get() : NULL; + smartarg1 = static_cast< Teuchos::RCP< Teuchos::ParameterList >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Teuchos::ParameterList* >(smartarg1->get()) : NULL; tempstr2 = std::string(static_cast(farg2->data), farg2->size); arg2 = &tempstr2; { @@ -1023,8 +1025,8 @@ SWIGEXPORT bool _wrap_ParameterList_is_parameter(SwigClassWrapper const *farg1, std::string tempstr2 ; bool result; - smartarg1 = static_cast< Teuchos::RCP* >(farg1->ptr); - arg1 = smartarg1 ? const_cast(smartarg1->get()) : NULL; + smartarg1 = static_cast< Teuchos::RCP* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Teuchos::ParameterList* >(smartarg1->get()) : NULL; tempstr2 = std::string(static_cast(farg2->data), farg2->size); arg2 = &tempstr2; { @@ -1050,7 +1052,7 @@ SWIGEXPORT bool _wrap_ParameterList_is_parameter(SwigClassWrapper const *farg1, SWIG_exception_impl("Teuchos::ParameterList::isParameter(std::string const &) const", SWIG_UnknownError, "An unknown exception occurred", return 0); } } - fresult = result; + fresult = static_cast< bool >(result); return fresult; } @@ -1063,8 +1065,8 @@ SWIGEXPORT SwigClassWrapper _wrap_ParameterList_sublist(SwigClassWrapper const * std::string tempstr2 ; Teuchos::ParameterList *result = 0 ; - smartarg1 = static_cast< Teuchos::RCP< Teuchos::ParameterList >* >(farg1->ptr); - arg1 = smartarg1 ? smartarg1->get() : NULL; + smartarg1 = static_cast< Teuchos::RCP< Teuchos::ParameterList >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Teuchos::ParameterList* >(smartarg1->get()) : NULL; tempstr2 = std::string(static_cast(farg2->data), farg2->size); arg2 = &tempstr2; { @@ -1091,7 +1093,7 @@ SWIGEXPORT SwigClassWrapper _wrap_ParameterList_sublist(SwigClassWrapper const * } } { - fresult.ptr = new Teuchos::RCP< Teuchos::ParameterList >(result SWIG_NO_NULL_DELETER_0); + fresult.cptr = new Teuchos::RCP< Teuchos::ParameterList >(result SWIG_NO_NULL_DELETER_0); fresult.mem = SWIG_MOVE; } return fresult; @@ -1104,12 +1106,14 @@ SWIGEXPORT void _wrap_ParameterList_set__SWIG_1(SwigClassWrapper const *farg1, S double *arg3 = 0 ; Teuchos::RCP< Teuchos::ParameterList > *smartarg1 ; std::string tempstr2 ; + double temp3 ; - smartarg1 = static_cast< Teuchos::RCP< Teuchos::ParameterList >* >(farg1->ptr); - arg1 = smartarg1 ? smartarg1->get() : NULL; + smartarg1 = static_cast< Teuchos::RCP< Teuchos::ParameterList >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Teuchos::ParameterList* >(smartarg1->get()) : NULL; tempstr2 = std::string(static_cast(farg2->data), farg2->size); arg2 = &tempstr2; - arg3 = reinterpret_cast< double * >(const_cast< double* >(farg3)); + temp3 = static_cast< double >(*farg3); + arg3 = &temp3; { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Teuchos::ParameterList::set< double >(std::string const &,double const &)");; @@ -1143,12 +1147,14 @@ SWIGEXPORT void _wrap_ParameterList_set__SWIG_2(SwigClassWrapper const *farg1, S int *arg3 = 0 ; Teuchos::RCP< Teuchos::ParameterList > *smartarg1 ; std::string tempstr2 ; + int temp3 ; - smartarg1 = static_cast< Teuchos::RCP< Teuchos::ParameterList >* >(farg1->ptr); - arg1 = smartarg1 ? smartarg1->get() : NULL; + smartarg1 = static_cast< Teuchos::RCP< Teuchos::ParameterList >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Teuchos::ParameterList* >(smartarg1->get()) : NULL; tempstr2 = std::string(static_cast(farg2->data), farg2->size); arg2 = &tempstr2; - arg3 = reinterpret_cast< int * >(const_cast< int* >(farg3)); + temp3 = static_cast< int >(*farg3); + arg3 = &temp3; { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Teuchos::ParameterList::set< int >(std::string const &,int const &)");; @@ -1182,12 +1188,14 @@ SWIGEXPORT void _wrap_ParameterList_set__SWIG_3(SwigClassWrapper const *farg1, S long long *arg3 = 0 ; Teuchos::RCP< Teuchos::ParameterList > *smartarg1 ; std::string tempstr2 ; + long long temp3 ; - smartarg1 = static_cast< Teuchos::RCP< Teuchos::ParameterList >* >(farg1->ptr); - arg1 = smartarg1 ? smartarg1->get() : NULL; + smartarg1 = static_cast< Teuchos::RCP< Teuchos::ParameterList >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Teuchos::ParameterList* >(smartarg1->get()) : NULL; tempstr2 = std::string(static_cast(farg2->data), farg2->size); arg2 = &tempstr2; - arg3 = reinterpret_cast< long long * >(const_cast< long long* >(farg3)); + temp3 = static_cast< long long >(*farg3); + arg3 = &temp3; { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Teuchos::ParameterList::set< long long >(std::string const &,long long const &)");; @@ -1221,12 +1229,14 @@ SWIGEXPORT void _wrap_ParameterList_set__SWIG_4(SwigClassWrapper const *farg1, S bool *arg3 = 0 ; Teuchos::RCP< Teuchos::ParameterList > *smartarg1 ; std::string tempstr2 ; + bool temp3 ; - smartarg1 = static_cast< Teuchos::RCP< Teuchos::ParameterList >* >(farg1->ptr); - arg1 = smartarg1 ? smartarg1->get() : NULL; + smartarg1 = static_cast< Teuchos::RCP< Teuchos::ParameterList >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Teuchos::ParameterList* >(smartarg1->get()) : NULL; tempstr2 = std::string(static_cast(farg2->data), farg2->size); arg2 = &tempstr2; - arg3 = reinterpret_cast< bool * >(const_cast< bool* >(farg3)); + temp3 = static_cast< bool >(*farg3); + arg3 = &temp3; { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Teuchos::ParameterList::set< bool >(std::string const &,bool const &)");; @@ -1262,8 +1272,8 @@ SWIGEXPORT void _wrap_ParameterList_set__SWIG_5(SwigClassWrapper const *farg1, S std::string tempstr2 ; std::string tempstr3 ; - smartarg1 = static_cast< Teuchos::RCP< Teuchos::ParameterList >* >(farg1->ptr); - arg1 = smartarg1 ? smartarg1->get() : NULL; + smartarg1 = static_cast< Teuchos::RCP< Teuchos::ParameterList >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Teuchos::ParameterList* >(smartarg1->get()) : NULL; tempstr2 = std::string(static_cast(farg2->data), farg2->size); arg2 = &tempstr2; tempstr3 = std::string(static_cast(farg3->data), farg3->size); @@ -1304,8 +1314,8 @@ SWIGEXPORT void _wrap_ParameterList_set__SWIG_6(SwigClassWrapper const *farg1, S Teuchos::Array< double > temparr3 ; Teuchos::Array< double >::value_type *tempbegin3 ; - smartarg1 = static_cast< Teuchos::RCP< Teuchos::ParameterList >* >(farg1->ptr); - arg1 = smartarg1 ? smartarg1->get() : NULL; + smartarg1 = static_cast< Teuchos::RCP< Teuchos::ParameterList >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Teuchos::ParameterList* >(smartarg1->get()) : NULL; tempstr2 = std::string(static_cast(farg2->data), farg2->size); arg2 = &tempstr2; tempbegin3 = static_cast::value_type*>(farg3->data); @@ -1347,8 +1357,8 @@ SWIGEXPORT void _wrap_ParameterList_set__SWIG_7(SwigClassWrapper const *farg1, S Teuchos::Array< int > temparr3 ; Teuchos::Array< int >::value_type *tempbegin3 ; - smartarg1 = static_cast< Teuchos::RCP< Teuchos::ParameterList >* >(farg1->ptr); - arg1 = smartarg1 ? smartarg1->get() : NULL; + smartarg1 = static_cast< Teuchos::RCP< Teuchos::ParameterList >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Teuchos::ParameterList* >(smartarg1->get()) : NULL; tempstr2 = std::string(static_cast(farg2->data), farg2->size); arg2 = &tempstr2; tempbegin3 = static_cast::value_type*>(farg3->data); @@ -1390,8 +1400,8 @@ SWIGEXPORT void _wrap_ParameterList_set__SWIG_8(SwigClassWrapper const *farg1, S Teuchos::Array< long long > temparr3 ; Teuchos::Array< long long >::value_type *tempbegin3 ; - smartarg1 = static_cast< Teuchos::RCP< Teuchos::ParameterList >* >(farg1->ptr); - arg1 = smartarg1 ? smartarg1->get() : NULL; + smartarg1 = static_cast< Teuchos::RCP< Teuchos::ParameterList >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Teuchos::ParameterList* >(smartarg1->get()) : NULL; tempstr2 = std::string(static_cast(farg2->data), farg2->size); arg2 = &tempstr2; tempbegin3 = static_cast::value_type*>(farg3->data); @@ -1432,13 +1442,13 @@ SWIGEXPORT void _wrap_ParameterList_set__SWIG_9(SwigClassWrapper const *farg1, S std::string tempstr2 ; Teuchos::RCP< Teuchos::ParameterList const > *smartarg3 ; - smartarg1 = static_cast< Teuchos::RCP< Teuchos::ParameterList >* >(farg1->ptr); - arg1 = smartarg1 ? smartarg1->get() : NULL; + smartarg1 = static_cast< Teuchos::RCP< Teuchos::ParameterList >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Teuchos::ParameterList* >(smartarg1->get()) : NULL; tempstr2 = std::string(static_cast(farg2->data), farg2->size); arg2 = &tempstr2; SWIG_check_sp_nonnull(farg3, "Teuchos::ParameterList *", "ParameterList", "Teuchos::ParameterList::set< Teuchos::ParameterList >(std::string const &,Teuchos::ParameterList const &)", return ) - smartarg3 = static_cast< Teuchos::RCP* >(farg3->ptr); - arg3 = const_cast(smartarg3->get()); + smartarg3 = static_cast< Teuchos::RCP* >(farg3->cptr); + arg3 = const_cast< Teuchos::ParameterList* >(smartarg3->get()); { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Teuchos::ParameterList::set< Teuchos::ParameterList >(std::string const &,Teuchos::ParameterList const &)");; @@ -1474,8 +1484,8 @@ SWIGEXPORT double _wrap_ParameterList_get_real(SwigClassWrapper const *farg1, Sw std::string tempstr2 ; double *result = 0 ; - smartarg1 = static_cast< Teuchos::RCP< Teuchos::ParameterList >* >(farg1->ptr); - arg1 = smartarg1 ? smartarg1->get() : NULL; + smartarg1 = static_cast< Teuchos::RCP< Teuchos::ParameterList >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Teuchos::ParameterList* >(smartarg1->get()) : NULL; tempstr2 = std::string(static_cast(farg2->data), farg2->size); arg2 = &tempstr2; { @@ -1514,8 +1524,8 @@ SWIGEXPORT int _wrap_ParameterList_get_integer(SwigClassWrapper const *farg1, Sw std::string tempstr2 ; int *result = 0 ; - smartarg1 = static_cast< Teuchos::RCP< Teuchos::ParameterList >* >(farg1->ptr); - arg1 = smartarg1 ? smartarg1->get() : NULL; + smartarg1 = static_cast< Teuchos::RCP< Teuchos::ParameterList >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Teuchos::ParameterList* >(smartarg1->get()) : NULL; tempstr2 = std::string(static_cast(farg2->data), farg2->size); arg2 = &tempstr2; { @@ -1554,8 +1564,8 @@ SWIGEXPORT long long _wrap_ParameterList_get_longlong(SwigClassWrapper const *fa std::string tempstr2 ; long long *result = 0 ; - smartarg1 = static_cast< Teuchos::RCP< Teuchos::ParameterList >* >(farg1->ptr); - arg1 = smartarg1 ? smartarg1->get() : NULL; + smartarg1 = static_cast< Teuchos::RCP< Teuchos::ParameterList >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Teuchos::ParameterList* >(smartarg1->get()) : NULL; tempstr2 = std::string(static_cast(farg2->data), farg2->size); arg2 = &tempstr2; { @@ -1594,8 +1604,8 @@ SWIGEXPORT bool _wrap_ParameterList_get_logical(SwigClassWrapper const *farg1, S std::string tempstr2 ; bool *result = 0 ; - smartarg1 = static_cast< Teuchos::RCP< Teuchos::ParameterList >* >(farg1->ptr); - arg1 = smartarg1 ? smartarg1->get() : NULL; + smartarg1 = static_cast< Teuchos::RCP< Teuchos::ParameterList >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Teuchos::ParameterList* >(smartarg1->get()) : NULL; tempstr2 = std::string(static_cast(farg2->data), farg2->size); arg2 = &tempstr2; { @@ -1634,8 +1644,8 @@ SWIGEXPORT SwigArrayWrapper _wrap_ParameterList_get_string(SwigClassWrapper cons std::string tempstr2 ; std::string *result = 0 ; - smartarg1 = static_cast< Teuchos::RCP< Teuchos::ParameterList >* >(farg1->ptr); - arg1 = smartarg1 ? smartarg1->get() : NULL; + smartarg1 = static_cast< Teuchos::RCP< Teuchos::ParameterList >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Teuchos::ParameterList* >(smartarg1->get()) : NULL; tempstr2 = std::string(static_cast(farg2->data), farg2->size); arg2 = &tempstr2; { @@ -1675,8 +1685,8 @@ SWIGEXPORT SwigArrayWrapper _wrap_ParameterList_get_arr_real(SwigClassWrapper co std::string tempstr2 ; Teuchos::Array< double > *result = 0 ; - smartarg1 = static_cast< Teuchos::RCP< Teuchos::ParameterList >* >(farg1->ptr); - arg1 = smartarg1 ? smartarg1->get() : NULL; + smartarg1 = static_cast< Teuchos::RCP< Teuchos::ParameterList >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Teuchos::ParameterList* >(smartarg1->get()) : NULL; tempstr2 = std::string(static_cast(farg2->data), farg2->size); arg2 = &tempstr2; { @@ -1716,8 +1726,8 @@ SWIGEXPORT SwigArrayWrapper _wrap_ParameterList_get_arr_integer(SwigClassWrapper std::string tempstr2 ; Teuchos::Array< int > *result = 0 ; - smartarg1 = static_cast< Teuchos::RCP< Teuchos::ParameterList >* >(farg1->ptr); - arg1 = smartarg1 ? smartarg1->get() : NULL; + smartarg1 = static_cast< Teuchos::RCP< Teuchos::ParameterList >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Teuchos::ParameterList* >(smartarg1->get()) : NULL; tempstr2 = std::string(static_cast(farg2->data), farg2->size); arg2 = &tempstr2; { @@ -1757,8 +1767,8 @@ SWIGEXPORT SwigArrayWrapper _wrap_ParameterList_get_arr_longlong(SwigClassWrappe std::string tempstr2 ; Teuchos::Array< long long > *result = 0 ; - smartarg1 = static_cast< Teuchos::RCP< Teuchos::ParameterList >* >(farg1->ptr); - arg1 = smartarg1 ? smartarg1->get() : NULL; + smartarg1 = static_cast< Teuchos::RCP< Teuchos::ParameterList >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Teuchos::ParameterList* >(smartarg1->get()) : NULL; tempstr2 = std::string(static_cast(farg2->data), farg2->size); arg2 = &tempstr2; { @@ -1794,8 +1804,8 @@ SWIGEXPORT void _wrap_delete_ParameterList(SwigClassWrapper const *farg1) { Teuchos::ParameterList *arg1 = (Teuchos::ParameterList *) 0 ; Teuchos::RCP< Teuchos::ParameterList > *smartarg1 ; - smartarg1 = static_cast< Teuchos::RCP< Teuchos::ParameterList >* >(farg1->ptr); - arg1 = smartarg1 ? smartarg1->get() : NULL; + smartarg1 = static_cast< Teuchos::RCP< Teuchos::ParameterList >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Teuchos::ParameterList* >(smartarg1->get()) : NULL; { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Teuchos::ParameterList::~ParameterList()");; @@ -1824,7 +1834,7 @@ SWIGEXPORT void _wrap_delete_ParameterList(SwigClassWrapper const *farg1) { SWIGEXPORT void _wrap_assign_ParameterList(SwigClassWrapper * self, SwigClassWrapper const * other) { - typedef ::Teuchos::RCP< Teuchos::ParameterList > swig_lhs_classtype; + typedef Teuchos::RCP< Teuchos::ParameterList > swig_lhs_classtype; SWIG_assign(swig_lhs_classtype, self, swig_lhs_classtype, const_cast(other), 0 | swig::IS_DESTR | swig::IS_COPY_CONSTR); @@ -1837,7 +1847,7 @@ SWIGEXPORT void _wrap_load_from_xml(SwigClassWrapper const *farg1, SwigArrayWrap Teuchos::RCP< Teuchos::ParameterList > tempnull1 ; std::string tempstr2 ; - arg1 = farg1->ptr ? static_cast< Teuchos::RCP< Teuchos::ParameterList > * >(farg1->ptr) : &tempnull1; + arg1 = farg1->cptr ? static_cast< Teuchos::RCP< Teuchos::ParameterList > * >(farg1->cptr) : &tempnull1; tempstr2 = std::string(static_cast(farg2->data), farg2->size); arg2 = &tempstr2; { @@ -1874,8 +1884,8 @@ SWIGEXPORT void _wrap_save_to_xml(SwigClassWrapper const *farg1, SwigArrayWrappe std::string tempstr2 ; SWIG_check_sp_nonnull(farg1, "Teuchos::ParameterList *", "ParameterList", "save_to_xml(Teuchos::ParameterList const &,std::string const &)", return ) - smartarg1 = static_cast< Teuchos::RCP* >(farg1->ptr); - arg1 = const_cast(smartarg1->get()); + smartarg1 = static_cast< Teuchos::RCP* >(farg1->cptr); + arg1 = const_cast< Teuchos::ParameterList* >(smartarg1->get()); tempstr2 = std::string(static_cast(farg2->data), farg2->size); arg2 = &tempstr2; { diff --git a/src/teuchos/test/test_teuchos_comm.f90 b/src/teuchos/test/test_teuchos_comm.f90 index 734d569b..f11f5f11 100644 --- a/src/teuchos/test/test_teuchos_comm.f90 +++ b/src/teuchos/test/test_teuchos_comm.f90 @@ -33,13 +33,13 @@ program test_TeuchosComm #ifdef HAVE_MPI comm = TeuchosComm(MPI_COMM_WORLD); TEST_IERR() - TEST_ASSERT(c_associated(comm%swigdata%ptr)) + TEST_ASSERT(c_associated(comm%swigdata%cptr)) call MPI_COMM_RANK(MPI_COMM_WORLD, comm_rank_f, ierr) call MPI_COMM_SIZE(MPI_COMM_WORLD, comm_size_f, ierr) #else comm = TeuchosComm(); TEST_IERR() - TEST_ASSERT(c_associated(comm%swigdata%ptr)) + TEST_ASSERT(c_associated(comm%swigdata%cptr)) comm_rank_f = 0 comm_size_f = 1 diff --git a/src/teuchos/test/test_teuchos_plist.f90 b/src/teuchos/test/test_teuchos_plist.f90 index 0b5069f9..623fb54a 100644 --- a/src/teuchos/test/test_teuchos_plist.f90 +++ b/src/teuchos/test/test_teuchos_plist.f90 @@ -37,11 +37,11 @@ program test_TeuchosPList OUT0('Starting TeuchosPList_Basic!') plist = ParameterList('myname'); TEST_IERR() - TEST_ASSERT(c_associated(plist%swigdata%ptr)) + TEST_ASSERT(c_associated(plist%swigdata%cptr)) ! Test a function that raises an exception TEST_THROW(call load_from_xml(plist, 'nonexistent_path.xml')) - TEST_ASSERT(c_associated(plist%swigdata%ptr)) + TEST_ASSERT(c_associated(plist%swigdata%cptr)) ! Get and set a vlaue call plist%set('myint', 4) @@ -77,9 +77,9 @@ program test_TeuchosPList call plist%remove('deleteme') TEST_ASSERT((.not. plist%is_parameter('deleteme'))) - TEST_ASSERT((.not. c_associated(sublist%swigdata%ptr))) + TEST_ASSERT((.not. c_associated(sublist%swigdata%cptr))) sublist = plist%sublist('sublist') - TEST_ASSERT(c_associated(sublist%swigdata%ptr)) + TEST_ASSERT(c_associated(sublist%swigdata%cptr)) call sublist%set('anotherval', 4.0d0) diff --git a/src/tpetra/src/Tpetra_Map.i b/src/tpetra/src/Tpetra_Map.i index 55457de4..390124f5 100644 --- a/src/tpetra/src/Tpetra_Map.i +++ b/src/tpetra/src/Tpetra_Map.i @@ -15,7 +15,7 @@ #include "Tpetra_Map.hpp" %} -%insert("fpublic") %{ +%insert("fdecl") %{ integer(global_ordinal_type), parameter, public :: TPETRA_GLOBAL_INVALID = -1 integer(local_ordinal_type), parameter, public :: TPETRA_LOCAL_INVALID = 0 %} diff --git a/src/tpetra/src/Tpetra_Operator.i b/src/tpetra/src/Tpetra_Operator.i index eb737346..8bb89814 100644 --- a/src/tpetra/src/Tpetra_Operator.i +++ b/src/tpetra/src/Tpetra_Operator.i @@ -90,12 +90,12 @@ SwigClassWrapper swigd_ForTpetraOperator_getRangeMap( Teuchos::RCP tempthis( const_cast(this) SWIG_NO_NULL_DELETER_0); SwigClassWrapper self; - self.ptr = &tempthis; + self.cptr = &tempthis; self.mem = SWIG_CREF; // since this function is const SwigClassWrapper fresult = swigd_ForTpetraOperator_getDomainMap(&self); - Teuchos::RCP* smartresult = static_cast< Teuchos::RCP* >(fresult.ptr); + Teuchos::RCP* smartresult = static_cast< Teuchos::RCP* >(fresult.cptr); return *smartresult; } @@ -104,12 +104,12 @@ SwigClassWrapper swigd_ForTpetraOperator_getRangeMap( Teuchos::RCP tempthis( const_cast(this) SWIG_NO_NULL_DELETER_0); SwigClassWrapper self; - self.ptr = &tempthis; + self.cptr = &tempthis; self.mem = SWIG_CREF; // since this function is const SwigClassWrapper fresult = swigd_ForTpetraOperator_getRangeMap(&self); - Teuchos::RCP* smartresult = static_cast< Teuchos::RCP* >(fresult.ptr); + Teuchos::RCP* smartresult = static_cast< Teuchos::RCP* >(fresult.cptr); return *smartresult; } @@ -120,20 +120,20 @@ SwigClassWrapper swigd_ForTpetraOperator_getRangeMap( Teuchos::RCP tempthis( const_cast(this) SWIG_NO_NULL_DELETER_0); SwigClassWrapper self; - self.ptr = &tempthis; + self.cptr = &tempthis; self.mem = SWIG_CREF; // since this function is const /* convert X -> class wrapper */ Teuchos::RCP > temprcp1(&X SWIG_NO_NULL_DELETER_0); SwigClassWrapper farg1; - farg1.ptr = &temprcp1; + farg1.cptr = &temprcp1; farg1.mem = SWIG_CREF; // X is const Teuchos::RCP< Tpetra::MultiVector > temprcp2(&Y SWIG_NO_NULL_DELETER_0); SwigClassWrapper farg2; - farg2.ptr = &temprcp2; + farg2.cptr = &temprcp2; farg2.mem = SWIG_REF; // Y is mutable /* convert scalars to wrappers */ @@ -146,17 +146,17 @@ SwigClassWrapper swigd_ForTpetraOperator_getRangeMap( }; %} -%insert("ftypes") %{ +%insert("fdecl") %{ type :: ForTpetraOperatorHandle class(ForTpetraOperator), pointer :: data end type %} -%insert("fpublic") %{ +%insert("fdecl") %{ public :: init_ForTpetraOperator %} -%insert("fwrapper") %{ +%insert("fsubprograms") %{ ! Convert a ISO-C class pointer struct into a user Fortran native pointer subroutine c_f_pointer_ForTpetraOperator(clswrap, fptr) type(SwigClassWrapper), intent(in) :: clswrap diff --git a/src/tpetra/src/fortpetra.f90 b/src/tpetra/src/fortpetra.f90 index b44ee7f8..ca464cd0 100644 --- a/src/tpetra/src/fortpetra.f90 +++ b/src/tpetra/src/fortpetra.f90 @@ -34,7 +34,7 @@ module fortpetra implicit none private - ! PUBLIC METHODS AND TYPES + ! DECLARATION CONSTRUCTS public :: scalar_type public :: local_ordinal_type @@ -46,121 +46,86 @@ module fortpetra public :: mag_type public :: norm_type - public :: TpetraLocalGlobal, TpetraLocallyReplicated, TpetraGloballyDistributed - public :: TpetraLookupStatus, TpetraAllIDsPresent, TpetraIDNotPresent - public :: TpetraProfileType, TpetraStaticProfile, TpetraDynamicProfile - public :: TpetraOptimizeOption, TpetraDoOptimizeStorage, TpetraDoNotOptimizeStorage - public :: TpetraESweepDirection, TpetraForward, TpetraBackward, TpetraSymmetric - public :: TpetraCombineMode, TpetraADD, TpetraINSERT, TpetraREPLACE, TpetraABSMAX, TpetraZERO - - enum, bind(c) - enumerator :: SwigMemState = -1 - enumerator :: SWIG_NULL = 0 - enumerator :: SWIG_OWN - enumerator :: SWIG_MOVE - enumerator :: SWIG_REF - enumerator :: SWIG_CREF - end enum - - -type, bind(C) :: SwigClassWrapper - type(C_PTR), public :: ptr = C_NULL_PTR - integer(C_INT), public :: mem = SWIG_NULL -end type - - -type, bind(C) :: SwigArrayWrapper - type(C_PTR), public :: data = C_NULL_PTR - integer(C_SIZE_T), public :: size = 0 -end type - - public :: setCombineModeParameter - public :: combineModeToString - - integer(global_ordinal_type), parameter, public :: TPETRA_GLOBAL_INVALID = -1 - integer(local_ordinal_type), parameter, public :: TPETRA_LOCAL_INVALID = 0 - - public :: TpetraMap - public :: TpetraExport - -type :: SwigUnknownClass - type(SwigClassWrapper), public :: swigdata -end type - - public :: TpetraImport - public :: TpetraMultiVector - public :: TpetraOperator - public :: ForTpetraOperator - -public :: init_ForTpetraOperator - - public :: RowInfo - public :: TpetraELocalGlobal, TpetraLocalIndices, TpetraGlobalIndices - public :: TpetraCrsGraph - public :: TpetraCrsMatrix - public :: operator_to_matrix - public :: matrix_to_operator - public :: TpetraReader - public :: TpetraWriter - public :: TpetraMatrixMatrixAdd - interface TpetraMatrixMatrixAdd - module procedure TpetraMatrixMatrixAdd__SWIG_0, TpetraMatrixMatrixAdd__SWIG_1 - end interface - public :: TpetraMatrixMatrixMultiply - interface TpetraMatrixMatrixMultiply - module procedure TpetraMatrixMatrixMultiply__SWIG_0, TpetraMatrixMatrixMultiply__SWIG_1, TpetraMatrixMatrixMultiply__SWIG_2, & - TpetraMatrixMatrixMultiply__SWIG_3 - end interface - - ! PARAMETERS - integer(C_INT), parameter, public :: TPETRA_THROWS_EFFICIENCY_WARNINGS = 0_C_INT - integer(C_INT), parameter, public :: TPETRA_PRINTS_EFFICIENCY_WARNINGS = 0_C_INT - integer(C_INT), parameter, public :: TPETRA_THROWS_ABUSE_WARNINGS = 0_C_INT - integer(C_INT), parameter, public :: TPETRA_PRINTS_ABUSE_WARNINGS = 0_C_INT + integer(C_INT), protected, public, & + bind(C, name="_wrap_TPETRA_THROWS_EFFICIENCY_WARNINGS") :: TPETRA_THROWS_EFFICIENCY_WARNINGS + integer(C_INT), protected, public, & + bind(C, name="_wrap_TPETRA_PRINTS_EFFICIENCY_WARNINGS") :: TPETRA_PRINTS_EFFICIENCY_WARNINGS + integer(C_INT), protected, public, & + bind(C, name="_wrap_TPETRA_THROWS_ABUSE_WARNINGS") :: TPETRA_THROWS_ABUSE_WARNINGS + integer(C_INT), protected, public, & + bind(C, name="_wrap_TPETRA_PRINTS_ABUSE_WARNINGS") :: TPETRA_PRINTS_ABUSE_WARNINGS + ! enum Tpetra::LocalGlobal enum, bind(c) - enumerator :: TpetraLocalGlobal = -1 - enumerator :: TpetraLocallyReplicated = 0 - enumerator :: TpetraGloballyDistributed = TpetraLocallyReplicated + 1 + enumerator :: TpetraLocallyReplicated + enumerator :: TpetraGloballyDistributed end enum + integer, parameter, public :: TpetraLocalGlobal = kind(TpetraLocallyReplicated) + public :: TpetraLocallyReplicated, TpetraGloballyDistributed + ! enum Tpetra::LookupStatus enum, bind(c) - enumerator :: TpetraLookupStatus = -1 - enumerator :: TpetraAllIDsPresent = 0 - enumerator :: TpetraIDNotPresent = TpetraAllIDsPresent + 1 + enumerator :: TpetraAllIDsPresent + enumerator :: TpetraIDNotPresent end enum + integer, parameter, public :: TpetraLookupStatus = kind(TpetraAllIDsPresent) + public :: TpetraAllIDsPresent, TpetraIDNotPresent + ! enum Tpetra::ProfileType enum, bind(c) - enumerator :: TpetraProfileType = -1 - enumerator :: TpetraStaticProfile = 0 - enumerator :: TpetraDynamicProfile = TpetraStaticProfile + 1 + enumerator :: TpetraStaticProfile + enumerator :: TpetraDynamicProfile end enum + integer, parameter, public :: TpetraProfileType = kind(TpetraStaticProfile) + public :: TpetraStaticProfile, TpetraDynamicProfile + ! enum Tpetra::OptimizeOption enum, bind(c) - enumerator :: TpetraOptimizeOption = -1 - enumerator :: TpetraDoOptimizeStorage = 0 - enumerator :: TpetraDoNotOptimizeStorage = TpetraDoOptimizeStorage + 1 + enumerator :: TpetraDoOptimizeStorage + enumerator :: TpetraDoNotOptimizeStorage end enum + integer, parameter, public :: TpetraOptimizeOption = kind(TpetraDoOptimizeStorage) + public :: TpetraDoOptimizeStorage, TpetraDoNotOptimizeStorage + ! enum Tpetra::ESweepDirection enum, bind(c) - enumerator :: TpetraESweepDirection = -1 enumerator :: TpetraForward = 0 - enumerator :: TpetraBackward = TpetraForward + 1 - enumerator :: TpetraSymmetric = TpetraBackward + 1 + enumerator :: TpetraBackward + enumerator :: TpetraSymmetric end enum - integer(C_INT), parameter, public :: TPETRA_USE_KOKKOS_DISTOBJECT = 0_C_INT + integer, parameter, public :: TpetraESweepDirection = kind(TpetraForward) + public :: TpetraForward, TpetraBackward, TpetraSymmetric + integer(C_INT), protected, public, & + bind(C, name="_wrap_TPETRA_USE_KOKKOS_DISTOBJECT") :: TPETRA_USE_KOKKOS_DISTOBJECT + ! enum Tpetra::CombineMode enum, bind(c) - enumerator :: TpetraCombineMode = -1 - enumerator :: TpetraADD = 0 - enumerator :: TpetraINSERT = TpetraADD + 1 - enumerator :: TpetraREPLACE = TpetraINSERT + 1 - enumerator :: TpetraABSMAX = TpetraREPLACE + 1 - enumerator :: TpetraZERO = TpetraABSMAX + 1 + enumerator :: TpetraADD + enumerator :: TpetraINSERT + enumerator :: TpetraREPLACE + enumerator :: TpetraABSMAX + enumerator :: TpetraZERO end enum + integer, parameter, public :: TpetraCombineMode = kind(TpetraADD) + public :: TpetraADD, TpetraINSERT, TpetraREPLACE, TpetraABSMAX, TpetraZERO enum, bind(c) - enumerator :: TpetraELocalGlobal = -1 - enumerator :: TpetraLocalIndices = 0 - enumerator :: TpetraGlobalIndices = TpetraLocalIndices + 1 + enumerator :: SWIG_NULL + enumerator :: SWIG_OWN + enumerator :: SWIG_MOVE + enumerator :: SWIG_REF + enumerator :: SWIG_CREF end enum + integer, parameter :: SwigMemState = kind(SWIG_NULL) + type, bind(C) :: SwigClassWrapper + type(C_PTR), public :: cptr = C_NULL_PTR + integer(C_INT), public :: mem = SWIG_NULL + end type + type, bind(C) :: SwigArrayWrapper + type(C_PTR), public :: data = C_NULL_PTR + integer(C_SIZE_T), public :: size = 0 + end type + public :: setCombineModeParameter + public :: combineModeToString - ! TYPES - type :: TpetraMap - ! These should be treated as PROTECTED data + integer(global_ordinal_type), parameter, public :: TPETRA_GLOBAL_INVALID = -1 + integer(local_ordinal_type), parameter, public :: TPETRA_LOCAL_INVALID = 0 + + ! class Tpetra::Map< LO,GO,NO > + type, public :: TpetraMap type(SwigClassWrapper), public :: swigdata contains procedure :: release => delete_TpetraMap @@ -196,14 +161,17 @@ module fortpetra generic :: getRemoteIndexList => getRemoteIndexList__SWIG_0, getRemoteIndexList__SWIG_1 end type TpetraMap interface TpetraMap - procedure new_TpetraMap__SWIG_0 - procedure new_TpetraMap__SWIG_1 - procedure new_TpetraMap__SWIG_2 - procedure new_TpetraMap__SWIG_3 - procedure new_TpetraMap__SWIG_4 + module procedure new_TpetraMap__SWIG_0 + module procedure new_TpetraMap__SWIG_1 + module procedure new_TpetraMap__SWIG_2 + module procedure new_TpetraMap__SWIG_3 + module procedure new_TpetraMap__SWIG_4 end interface - type :: TpetraExport - ! These should be treated as PROTECTED data + type, public :: SWIGTYPE_ImportT_int_long_long_Kokkos__Compat__KokkosSeri1YW4XR + type(SwigClassWrapper), public :: swigdata + end type + ! class Tpetra::Export< LO,GO,NO > + type, public :: TpetraExport type(SwigClassWrapper), public :: swigdata contains procedure :: release => delete_TpetraExport @@ -219,13 +187,13 @@ module fortpetra generic :: assignment(=) => swigf_assignment_TpetraExport end type TpetraExport interface TpetraExport - procedure new_TpetraExport__SWIG_0 - procedure new_TpetraExport__SWIG_1 - procedure new_TpetraExport__SWIG_2 - procedure new_TpetraExport__SWIG_3 + module procedure new_TpetraExport__SWIG_0 + module procedure new_TpetraExport__SWIG_1 + module procedure new_TpetraExport__SWIG_2 + module procedure new_TpetraExport__SWIG_3 end interface - type :: TpetraImport - ! These should be treated as PROTECTED data + ! class Tpetra::Import< LO,GO,NO > + type, public :: TpetraImport type(SwigClassWrapper), public :: swigdata contains procedure :: release => delete_TpetraImport @@ -245,13 +213,15 @@ module fortpetra generic :: setUnion => setUnion__SWIG_0, setUnion__SWIG_1 end type TpetraImport interface TpetraImport - procedure new_TpetraImport__SWIG_0 - procedure new_TpetraImport__SWIG_1 - procedure new_TpetraImport__SWIG_2 - procedure new_TpetraImport__SWIG_3 + module procedure new_TpetraImport__SWIG_0 + module procedure new_TpetraImport__SWIG_1 + module procedure new_TpetraImport__SWIG_2 + module procedure new_TpetraImport__SWIG_3 end interface - type :: TpetraMultiVector - ! These should be treated as PROTECTED data +integer, parameter, public :: SWIGTYPE_Teuchos__DataAccess = C_INT +integer, parameter, public :: SWIGTYPE_Teuchos__ETransp = C_INT + ! class Tpetra::MultiVector< SC,LO,GO,NO > + type, public :: TpetraMultiVector type(SwigClassWrapper), public :: swigdata contains procedure :: swap => swigf_TpetraMultiVector_swap @@ -322,24 +292,25 @@ module fortpetra generic :: update => update__SWIG_0, update__SWIG_1 end type TpetraMultiVector interface TpetraMultiVector - procedure new_TpetraMultiVector__SWIG_0 - procedure new_TpetraMultiVector__SWIG_1 - procedure new_TpetraMultiVector__SWIG_2 - procedure new_TpetraMultiVector__SWIG_3 - procedure new_TpetraMultiVector__SWIG_4 - procedure new_TpetraMultiVector__SWIG_6 - procedure new_TpetraMultiVector__SWIG_7 - procedure new_TpetraMultiVector__SWIG_8 + module procedure new_TpetraMultiVector__SWIG_0 + module procedure new_TpetraMultiVector__SWIG_1 + module procedure new_TpetraMultiVector__SWIG_2 + module procedure new_TpetraMultiVector__SWIG_3 + module procedure new_TpetraMultiVector__SWIG_4 + module procedure new_TpetraMultiVector__SWIG_6 + module procedure new_TpetraMultiVector__SWIG_7 + module procedure new_TpetraMultiVector__SWIG_8 end interface - type :: TpetraOperator - ! These should be treated as PROTECTED data + ! class Tpetra::Operator< SC,LO,GO,NO > + type, public :: TpetraOperator type(SwigClassWrapper), public :: swigdata contains procedure :: release => delete_TpetraOperator procedure, private :: swigf_assignment_TpetraOperator generic :: assignment(=) => swigf_assignment_TpetraOperator end type TpetraOperator - type, extends(TpetraOperator) :: ForTpetraOperator + ! class ForTpetraOperator + type, extends(TpetraOperator), public :: ForTpetraOperator contains procedure :: fhandle => swigf_ForTpetraOperator_fhandle procedure :: init => swigf_ForTpetraOperator_init @@ -351,15 +322,18 @@ module fortpetra generic :: assignment(=) => swigf_assignment_ForTpetraOperator end type ForTpetraOperator interface ForTpetraOperator - procedure new_ForTpetraOperator + module procedure new_ForTpetraOperator end interface type :: ForTpetraOperatorHandle class(ForTpetraOperator), pointer :: data end type - type :: RowInfo - ! These should be treated as PROTECTED data + +public :: init_ForTpetraOperator + + ! struct Tpetra::RowInfo + type, public :: RowInfo type(SwigClassWrapper), public :: swigdata contains procedure :: set_localRow => RowInfo_localRow_set @@ -375,10 +349,17 @@ module fortpetra generic :: assignment(=) => swigf_assignment_RowInfo end type RowInfo interface RowInfo - procedure new_RowInfo + module procedure new_RowInfo end interface - type :: TpetraCrsGraph - ! These should be treated as PROTECTED data + ! enum Tpetra::ELocalGlobal + enum, bind(c) + enumerator :: TpetraLocalIndices + enumerator :: TpetraGlobalIndices + end enum + integer, parameter, public :: TpetraELocalGlobal = kind(TpetraLocalIndices) + public :: TpetraLocalIndices, TpetraGlobalIndices + ! class Tpetra::CrsGraph< LO,GO,NO > + type, public :: TpetraCrsGraph type(SwigClassWrapper), public :: swigdata contains procedure :: release => delete_TpetraCrsGraph @@ -482,23 +463,26 @@ module fortpetra exportAndFillComplete__SWIG_2, exportAndFillComplete__SWIG_3, exportAndFillComplete__SWIG_4 end type TpetraCrsGraph interface TpetraCrsGraph - procedure new_TpetraCrsGraph__SWIG_0 - procedure new_TpetraCrsGraph__SWIG_1 - procedure new_TpetraCrsGraph__SWIG_2 - procedure new_TpetraCrsGraph__SWIG_3 - procedure new_TpetraCrsGraph__SWIG_4 - procedure new_TpetraCrsGraph__SWIG_5 - procedure new_TpetraCrsGraph__SWIG_6 - procedure new_TpetraCrsGraph__SWIG_7 - procedure new_TpetraCrsGraph__SWIG_8 - procedure new_TpetraCrsGraph__SWIG_9 - procedure new_TpetraCrsGraph__SWIG_10 - procedure new_TpetraCrsGraph__SWIG_11 - procedure new_TpetraCrsGraph__SWIG_12 - procedure new_TpetraCrsGraph__SWIG_13 + module procedure new_TpetraCrsGraph__SWIG_0 + module procedure new_TpetraCrsGraph__SWIG_1 + module procedure new_TpetraCrsGraph__SWIG_2 + module procedure new_TpetraCrsGraph__SWIG_3 + module procedure new_TpetraCrsGraph__SWIG_4 + module procedure new_TpetraCrsGraph__SWIG_5 + module procedure new_TpetraCrsGraph__SWIG_6 + module procedure new_TpetraCrsGraph__SWIG_7 + module procedure new_TpetraCrsGraph__SWIG_8 + module procedure new_TpetraCrsGraph__SWIG_9 + module procedure new_TpetraCrsGraph__SWIG_10 + module procedure new_TpetraCrsGraph__SWIG_11 + module procedure new_TpetraCrsGraph__SWIG_12 + module procedure new_TpetraCrsGraph__SWIG_13 end interface - type :: TpetraCrsMatrix - ! These should be treated as PROTECTED data + type, public :: SWIGTYPE_KokkosSparse__CrsMatrixT_Tpetra__CrsMatrixT_doub1E12GN + type(SwigClassWrapper), public :: swigdata + end type + ! class Tpetra::CrsMatrix< SC,LO,GO,NO > + type, public :: TpetraCrsMatrix type(SwigClassWrapper), public :: swigdata contains procedure :: release => delete_TpetraCrsMatrix @@ -603,27 +587,29 @@ module fortpetra exportAndFillComplete__SWIG_2, exportAndFillComplete__SWIG_3, exportAndFillComplete__SWIG_4 end type TpetraCrsMatrix interface TpetraCrsMatrix - procedure new_TpetraCrsMatrix__SWIG_0 - procedure new_TpetraCrsMatrix__SWIG_1 - procedure new_TpetraCrsMatrix__SWIG_2 - procedure new_TpetraCrsMatrix__SWIG_3 - procedure new_TpetraCrsMatrix__SWIG_4 - procedure new_TpetraCrsMatrix__SWIG_5 - procedure new_TpetraCrsMatrix__SWIG_6 - procedure new_TpetraCrsMatrix__SWIG_7 - procedure new_TpetraCrsMatrix__SWIG_8 - procedure new_TpetraCrsMatrix__SWIG_9 - procedure new_TpetraCrsMatrix__SWIG_10 - procedure new_TpetraCrsMatrix__SWIG_11 - procedure new_TpetraCrsMatrix__SWIG_12 - procedure new_TpetraCrsMatrix__SWIG_13 - procedure new_TpetraCrsMatrix__SWIG_14 - procedure new_TpetraCrsMatrix__SWIG_15 - procedure new_TpetraCrsMatrix__SWIG_16 - procedure new_TpetraCrsMatrix__SWIG_17 + module procedure new_TpetraCrsMatrix__SWIG_0 + module procedure new_TpetraCrsMatrix__SWIG_1 + module procedure new_TpetraCrsMatrix__SWIG_2 + module procedure new_TpetraCrsMatrix__SWIG_3 + module procedure new_TpetraCrsMatrix__SWIG_4 + module procedure new_TpetraCrsMatrix__SWIG_5 + module procedure new_TpetraCrsMatrix__SWIG_6 + module procedure new_TpetraCrsMatrix__SWIG_7 + module procedure new_TpetraCrsMatrix__SWIG_8 + module procedure new_TpetraCrsMatrix__SWIG_9 + module procedure new_TpetraCrsMatrix__SWIG_10 + module procedure new_TpetraCrsMatrix__SWIG_11 + module procedure new_TpetraCrsMatrix__SWIG_12 + module procedure new_TpetraCrsMatrix__SWIG_13 + module procedure new_TpetraCrsMatrix__SWIG_14 + module procedure new_TpetraCrsMatrix__SWIG_15 + module procedure new_TpetraCrsMatrix__SWIG_16 + module procedure new_TpetraCrsMatrix__SWIG_17 end interface - type :: TpetraReader - ! These should be treated as PROTECTED data + public :: operator_to_matrix + public :: matrix_to_operator + ! class Tpetra::MatrixMarket::Reader< CMT > + type, public :: TpetraReader type(SwigClassWrapper), public :: swigdata contains procedure, private, nopass :: readSparseGraphFile__SWIG_0 => TpetraReader_readSparseGraphFile__SWIG_0 @@ -667,10 +653,10 @@ module fortpetra generic :: readMapFile => readMapFile__SWIG_0, readMapFile__SWIG_1, readMapFile__SWIG_2 end type TpetraReader interface TpetraReader - procedure new_TpetraReader + module procedure new_TpetraReader end interface - type :: TpetraWriter - ! These should be treated as PROTECTED data + ! class Tpetra::MatrixMarket::Writer< CMT > + type, public :: TpetraWriter type(SwigClassWrapper), public :: swigdata contains procedure, nopass :: writeMapFile => TpetraWriter_writeMapFile @@ -694,17 +680,25 @@ module fortpetra generic :: writeDenseFile => writeDenseFile__SWIG_0, writeDenseFile__SWIG_1 end type TpetraWriter interface TpetraWriter - procedure new_TpetraWriter + module procedure new_TpetraWriter end interface + interface TpetraMatrixMatrixAdd + module procedure TpetraMatrixMatrixAdd__SWIG_0, TpetraMatrixMatrixAdd__SWIG_1 + end interface + public :: TpetraMatrixMatrixAdd + interface TpetraMatrixMatrixMultiply + module procedure TpetraMatrixMatrixMultiply__SWIG_0, TpetraMatrixMatrixMultiply__SWIG_1, TpetraMatrixMatrixMultiply__SWIG_2, & + TpetraMatrixMatrixMultiply__SWIG_3 + end interface + public :: TpetraMatrixMatrixMultiply - - ! WRAPPER DECLARATIONS - interface +! WRAPPER DECLARATIONS +interface subroutine swigc_setCombineModeParameter(farg1, farg2) & bind(C, name="_wrap_setCombineModeParameter") use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper -import :: SwigArrayWrapper +import :: swigclasswrapper +import :: swigarraywrapper type(SwigClassWrapper) :: farg1 type(SwigArrayWrapper) :: farg2 end subroutine @@ -713,30 +707,28 @@ function swigc_combineModeToString(farg1) & bind(C, name="_wrap_combineModeToString") & result(fresult) use, intrinsic :: ISO_C_BINDING -import :: SwigArrayWrapper +import :: swigarraywrapper integer(C_INT), intent(in) :: farg1 type(SwigArrayWrapper) :: fresult end function - -subroutine SWIG_free(ptr) & + subroutine SWIG_free(cptr) & bind(C, name="free") use, intrinsic :: ISO_C_BINDING - type(C_PTR), value :: ptr + type(C_PTR), value :: cptr end subroutine - function swigc_new_TpetraMap__SWIG_0() & bind(C, name="_wrap_new_TpetraMap__SWIG_0") & result(fresult) use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: fresult end function subroutine swigc_delete_TpetraMap(farg1) & bind(C, name="_wrap_delete_TpetraMap") use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 end subroutine @@ -744,7 +736,7 @@ function swigc_TpetraMap_isOneToOne(farg1) & bind(C, name="_wrap_TpetraMap_isOneToOne") & result(fresult) use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 logical(C_BOOL) :: fresult end function @@ -753,7 +745,7 @@ function swigc_TpetraMap_getGlobalNumElements(farg1) & bind(C, name="_wrap_TpetraMap_getGlobalNumElements") & result(fresult) use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 integer(C_LONG) :: fresult end function @@ -762,7 +754,7 @@ function swigc_TpetraMap_getNodeNumElements(farg1) & bind(C, name="_wrap_TpetraMap_getNodeNumElements") & result(fresult) use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 integer(C_SIZE_T) :: fresult end function @@ -771,7 +763,7 @@ function swigc_TpetraMap_getMinLocalIndex(farg1) & bind(C, name="_wrap_TpetraMap_getMinLocalIndex") & result(fresult) use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 integer(C_INT) :: fresult end function @@ -780,7 +772,7 @@ function swigc_TpetraMap_getMaxLocalIndex(farg1) & bind(C, name="_wrap_TpetraMap_getMaxLocalIndex") & result(fresult) use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 integer(C_INT) :: fresult end function @@ -789,7 +781,7 @@ function swigc_TpetraMap_getMinGlobalIndex(farg1) & bind(C, name="_wrap_TpetraMap_getMinGlobalIndex") & result(fresult) use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 integer(C_LONG_LONG) :: fresult end function @@ -798,7 +790,7 @@ function swigc_TpetraMap_getMaxGlobalIndex(farg1) & bind(C, name="_wrap_TpetraMap_getMaxGlobalIndex") & result(fresult) use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 integer(C_LONG_LONG) :: fresult end function @@ -807,7 +799,7 @@ function swigc_TpetraMap_getMinAllGlobalIndex(farg1) & bind(C, name="_wrap_TpetraMap_getMinAllGlobalIndex") & result(fresult) use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 integer(C_LONG_LONG) :: fresult end function @@ -816,7 +808,7 @@ function swigc_TpetraMap_getMaxAllGlobalIndex(farg1) & bind(C, name="_wrap_TpetraMap_getMaxAllGlobalIndex") & result(fresult) use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 integer(C_LONG_LONG) :: fresult end function @@ -825,7 +817,7 @@ function swigc_TpetraMap_getLocalElement(farg1, farg2) & bind(C, name="_wrap_TpetraMap_getLocalElement") & result(fresult) use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 integer(C_LONG_LONG), intent(in) :: farg2 integer(C_INT) :: fresult @@ -835,7 +827,7 @@ function swigc_TpetraMap_getGlobalElement(farg1, farg2) & bind(C, name="_wrap_TpetraMap_getGlobalElement") & result(fresult) use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 integer(C_INT), intent(in) :: farg2 integer(C_LONG_LONG) :: fresult @@ -845,7 +837,7 @@ function swigc_TpetraMap_isNodeLocalElement(farg1, farg2) & bind(C, name="_wrap_TpetraMap_isNodeLocalElement") & result(fresult) use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 integer(C_INT), intent(in) :: farg2 logical(C_BOOL) :: fresult @@ -855,7 +847,7 @@ function swigc_TpetraMap_isNodeGlobalElement(farg1, farg2) & bind(C, name="_wrap_TpetraMap_isNodeGlobalElement") & result(fresult) use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 integer(C_LONG_LONG), intent(in) :: farg2 logical(C_BOOL) :: fresult @@ -865,7 +857,7 @@ function swigc_TpetraMap_isUniform(farg1) & bind(C, name="_wrap_TpetraMap_isUniform") & result(fresult) use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 logical(C_BOOL) :: fresult end function @@ -874,7 +866,7 @@ function swigc_TpetraMap_isContiguous(farg1) & bind(C, name="_wrap_TpetraMap_isContiguous") & result(fresult) use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 logical(C_BOOL) :: fresult end function @@ -883,7 +875,7 @@ function swigc_TpetraMap_isDistributed(farg1) & bind(C, name="_wrap_TpetraMap_isDistributed") & result(fresult) use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 logical(C_BOOL) :: fresult end function @@ -892,7 +884,7 @@ function swigc_TpetraMap_isCompatible(farg1, farg2) & bind(C, name="_wrap_TpetraMap_isCompatible") & result(fresult) use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 logical(C_BOOL) :: fresult @@ -902,7 +894,7 @@ function swigc_TpetraMap_isSameAs(farg1, farg2) & bind(C, name="_wrap_TpetraMap_isSameAs") & result(fresult) use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 logical(C_BOOL) :: fresult @@ -912,7 +904,7 @@ function swigc_TpetraMap_locallySameAs(farg1, farg2) & bind(C, name="_wrap_TpetraMap_locallySameAs") & result(fresult) use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 logical(C_BOOL) :: fresult @@ -922,7 +914,7 @@ function swigc_TpetraMap_isLocallyFitted(farg1, farg2) & bind(C, name="_wrap_TpetraMap_isLocallyFitted") & result(fresult) use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 logical(C_BOOL) :: fresult @@ -932,7 +924,7 @@ function swigc_TpetraMap_getComm(farg1) & bind(C, name="_wrap_TpetraMap_getComm") & result(fresult) use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: fresult end function @@ -941,8 +933,8 @@ function swigc_TpetraMap_description(farg1) & bind(C, name="_wrap_TpetraMap_description") & result(fresult) use, intrinsic :: ISO_C_BINDING -import :: SwigArrayWrapper -import :: SwigClassWrapper +import :: swigarraywrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 type(SwigArrayWrapper) :: fresult end function @@ -951,7 +943,7 @@ function swigc_TpetraMap_removeEmptyProcesses(farg1) & bind(C, name="_wrap_TpetraMap_removeEmptyProcesses") & result(fresult) use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: fresult end function @@ -960,7 +952,7 @@ function swigc_TpetraMap_replaceCommWithSubset(farg1, farg2) & bind(C, name="_wrap_TpetraMap_replaceCommWithSubset") & result(fresult) use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 type(SwigClassWrapper) :: fresult @@ -970,7 +962,7 @@ function swigc_new_TpetraMap__SWIG_1(farg1, farg2, farg3) & bind(C, name="_wrap_new_TpetraMap__SWIG_1") & result(fresult) use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper integer(C_LONG), intent(in) :: farg1 type(SwigClassWrapper) :: farg2 integer(C_INT), intent(in) :: farg3 @@ -981,7 +973,7 @@ function swigc_new_TpetraMap__SWIG_2(farg1, farg2) & bind(C, name="_wrap_new_TpetraMap__SWIG_2") & result(fresult) use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper integer(C_LONG), intent(in) :: farg1 type(SwigClassWrapper) :: farg2 type(SwigClassWrapper) :: fresult @@ -991,7 +983,7 @@ function swigc_new_TpetraMap__SWIG_3(farg1, farg2, farg3) & bind(C, name="_wrap_new_TpetraMap__SWIG_3") & result(fresult) use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper integer(C_LONG), intent(in) :: farg1 integer(C_SIZE_T), intent(in) :: farg2 type(SwigClassWrapper) :: farg3 @@ -1002,8 +994,8 @@ function swigc_new_TpetraMap__SWIG_4(farg1, farg2, farg3) & bind(C, name="_wrap_new_TpetraMap__SWIG_4") & result(fresult) use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper -import :: SwigArrayWrapper +import :: swigclasswrapper +import :: swigarraywrapper integer(C_LONG), intent(in) :: farg1 type(SwigArrayWrapper) :: farg2 type(SwigClassWrapper) :: farg3 @@ -1014,8 +1006,8 @@ function swigc_TpetraMap_getRemoteIndexList__SWIG_0(farg1, farg2, farg3, farg4) bind(C, name="_wrap_TpetraMap_getRemoteIndexList__SWIG_0") & result(fresult) use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper -import :: SwigArrayWrapper +import :: swigclasswrapper +import :: swigarraywrapper type(SwigClassWrapper) :: farg1 type(SwigArrayWrapper) :: farg2 type(SwigArrayWrapper) :: farg3 @@ -1027,8 +1019,8 @@ function swigc_TpetraMap_getRemoteIndexList__SWIG_1(farg1, farg2, farg3) & bind(C, name="_wrap_TpetraMap_getRemoteIndexList__SWIG_1") & result(fresult) use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper -import :: SwigArrayWrapper +import :: swigclasswrapper +import :: swigarraywrapper type(SwigClassWrapper) :: farg1 type(SwigArrayWrapper) :: farg2 type(SwigArrayWrapper) :: farg3 @@ -1039,8 +1031,8 @@ function swigc_TpetraMap_getNodeElementList(farg1) & bind(C, name="_wrap_TpetraMap_getNodeElementList") & result(fresult) use, intrinsic :: ISO_C_BINDING -import :: SwigArrayWrapper -import :: SwigClassWrapper +import :: swigarraywrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 type(SwigArrayWrapper) :: fresult end function @@ -1056,7 +1048,7 @@ function swigc_new_TpetraExport__SWIG_0(farg1, farg2) & bind(C, name="_wrap_new_TpetraExport__SWIG_0") & result(fresult) use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 type(SwigClassWrapper) :: fresult @@ -1066,7 +1058,7 @@ function swigc_new_TpetraExport__SWIG_1(farg1, farg2, farg3) & bind(C, name="_wrap_new_TpetraExport__SWIG_1") & result(fresult) use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 type(SwigClassWrapper) :: farg3 @@ -1077,7 +1069,7 @@ function swigc_new_TpetraExport__SWIG_2(farg1) & bind(C, name="_wrap_new_TpetraExport__SWIG_2") & result(fresult) use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: fresult end function @@ -1086,7 +1078,7 @@ function swigc_new_TpetraExport__SWIG_3(farg1) & bind(C, name="_wrap_new_TpetraExport__SWIG_3") & result(fresult) use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: fresult end function @@ -1094,14 +1086,14 @@ function swigc_new_TpetraExport__SWIG_3(farg1) & subroutine swigc_delete_TpetraExport(farg1) & bind(C, name="_wrap_delete_TpetraExport") use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 end subroutine subroutine swigc_TpetraExport_setParameterList(farg1, farg2) & bind(C, name="_wrap_TpetraExport_setParameterList") use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 end subroutine @@ -1110,7 +1102,7 @@ function swigc_TpetraExport_getNumSameIDs(farg1) & bind(C, name="_wrap_TpetraExport_getNumSameIDs") & result(fresult) use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 integer(C_SIZE_T) :: fresult end function @@ -1119,7 +1111,7 @@ function swigc_TpetraExport_getNumPermuteIDs(farg1) & bind(C, name="_wrap_TpetraExport_getNumPermuteIDs") & result(fresult) use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 integer(C_SIZE_T) :: fresult end function @@ -1128,7 +1120,7 @@ function swigc_TpetraExport_getNumRemoteIDs(farg1) & bind(C, name="_wrap_TpetraExport_getNumRemoteIDs") & result(fresult) use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 integer(C_SIZE_T) :: fresult end function @@ -1137,7 +1129,7 @@ function swigc_TpetraExport_getNumExportIDs(farg1) & bind(C, name="_wrap_TpetraExport_getNumExportIDs") & result(fresult) use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 integer(C_SIZE_T) :: fresult end function @@ -1146,7 +1138,7 @@ function swigc_TpetraExport_getSourceMap(farg1) & bind(C, name="_wrap_TpetraExport_getSourceMap") & result(fresult) use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: fresult end function @@ -1155,7 +1147,7 @@ function swigc_TpetraExport_getTargetMap(farg1) & bind(C, name="_wrap_TpetraExport_getTargetMap") & result(fresult) use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: fresult end function @@ -1164,7 +1156,7 @@ function swigc_TpetraExport_isLocallyComplete(farg1) & bind(C, name="_wrap_TpetraExport_isLocallyComplete") & result(fresult) use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 logical(C_BOOL) :: fresult end function @@ -1180,7 +1172,7 @@ function swigc_new_TpetraImport__SWIG_0(farg1, farg2) & bind(C, name="_wrap_new_TpetraImport__SWIG_0") & result(fresult) use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 type(SwigClassWrapper) :: fresult @@ -1190,7 +1182,7 @@ function swigc_new_TpetraImport__SWIG_1(farg1, farg2, farg3) & bind(C, name="_wrap_new_TpetraImport__SWIG_1") & result(fresult) use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 type(SwigClassWrapper) :: farg3 @@ -1201,7 +1193,7 @@ function swigc_new_TpetraImport__SWIG_2(farg1) & bind(C, name="_wrap_new_TpetraImport__SWIG_2") & result(fresult) use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: fresult end function @@ -1210,7 +1202,7 @@ function swigc_new_TpetraImport__SWIG_3(farg1) & bind(C, name="_wrap_new_TpetraImport__SWIG_3") & result(fresult) use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: fresult end function @@ -1218,14 +1210,14 @@ function swigc_new_TpetraImport__SWIG_3(farg1) & subroutine swigc_delete_TpetraImport(farg1) & bind(C, name="_wrap_delete_TpetraImport") use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 end subroutine subroutine swigc_TpetraImport_setParameterList(farg1, farg2) & bind(C, name="_wrap_TpetraImport_setParameterList") use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 end subroutine @@ -1234,7 +1226,7 @@ function swigc_TpetraImport_getNumSameIDs(farg1) & bind(C, name="_wrap_TpetraImport_getNumSameIDs") & result(fresult) use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 integer(C_SIZE_T) :: fresult end function @@ -1243,7 +1235,7 @@ function swigc_TpetraImport_getNumPermuteIDs(farg1) & bind(C, name="_wrap_TpetraImport_getNumPermuteIDs") & result(fresult) use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 integer(C_SIZE_T) :: fresult end function @@ -1252,7 +1244,7 @@ function swigc_TpetraImport_getNumRemoteIDs(farg1) & bind(C, name="_wrap_TpetraImport_getNumRemoteIDs") & result(fresult) use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 integer(C_SIZE_T) :: fresult end function @@ -1261,7 +1253,7 @@ function swigc_TpetraImport_getNumExportIDs(farg1) & bind(C, name="_wrap_TpetraImport_getNumExportIDs") & result(fresult) use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 integer(C_SIZE_T) :: fresult end function @@ -1270,7 +1262,7 @@ function swigc_TpetraImport_getSourceMap(farg1) & bind(C, name="_wrap_TpetraImport_getSourceMap") & result(fresult) use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: fresult end function @@ -1279,7 +1271,7 @@ function swigc_TpetraImport_getTargetMap(farg1) & bind(C, name="_wrap_TpetraImport_getTargetMap") & result(fresult) use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: fresult end function @@ -1288,7 +1280,7 @@ function swigc_TpetraImport_isLocallyComplete(farg1) & bind(C, name="_wrap_TpetraImport_isLocallyComplete") & result(fresult) use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 logical(C_BOOL) :: fresult end function @@ -1297,7 +1289,7 @@ function swigc_TpetraImport_setUnion__SWIG_0(farg1, farg2) & bind(C, name="_wrap_TpetraImport_setUnion__SWIG_0") & result(fresult) use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 type(SwigClassWrapper) :: fresult @@ -1307,7 +1299,7 @@ function swigc_TpetraImport_setUnion__SWIG_1(farg1) & bind(C, name="_wrap_TpetraImport_setUnion__SWIG_1") & result(fresult) use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: fresult end function @@ -1316,7 +1308,7 @@ function swigc_TpetraImport_createRemoteOnlyImport(farg1, farg2) & bind(C, name="_wrap_TpetraImport_createRemoteOnlyImport") & result(fresult) use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 type(SwigClassWrapper) :: fresult @@ -1333,7 +1325,7 @@ function swigc_new_TpetraMultiVector__SWIG_0() & bind(C, name="_wrap_new_TpetraMultiVector__SWIG_0") & result(fresult) use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: fresult end function @@ -1341,7 +1333,7 @@ function swigc_new_TpetraMultiVector__SWIG_1(farg1, farg2, farg3) & bind(C, name="_wrap_new_TpetraMultiVector__SWIG_1") & result(fresult) use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 integer(C_SIZE_T), intent(in) :: farg2 logical(C_BOOL), intent(in) :: farg3 @@ -1352,7 +1344,7 @@ function swigc_new_TpetraMultiVector__SWIG_2(farg1, farg2) & bind(C, name="_wrap_new_TpetraMultiVector__SWIG_2") & result(fresult) use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 integer(C_SIZE_T), intent(in) :: farg2 type(SwigClassWrapper) :: fresult @@ -1362,7 +1354,7 @@ function swigc_new_TpetraMultiVector__SWIG_3(farg1) & bind(C, name="_wrap_new_TpetraMultiVector__SWIG_3") & result(fresult) use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: fresult end function @@ -1371,7 +1363,7 @@ function swigc_new_TpetraMultiVector__SWIG_4(farg1, farg2) & bind(C, name="_wrap_new_TpetraMultiVector__SWIG_4") & result(fresult) use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 integer(C_INT), intent(in) :: farg2 type(SwigClassWrapper) :: fresult @@ -1381,7 +1373,7 @@ function swigc_new_TpetraMultiVector__SWIG_6(farg1, farg2, farg3) & bind(C, name="_wrap_new_TpetraMultiVector__SWIG_6") & result(fresult) use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 integer(C_SIZE_T), intent(in) :: farg3 @@ -1392,7 +1384,7 @@ function swigc_new_TpetraMultiVector__SWIG_7(farg1, farg2) & bind(C, name="_wrap_new_TpetraMultiVector__SWIG_7") & result(fresult) use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 type(SwigClassWrapper) :: fresult @@ -1401,7 +1393,7 @@ function swigc_new_TpetraMultiVector__SWIG_7(farg1, farg2) & subroutine swigc_TpetraMultiVector_swap(farg1, farg2) & bind(C, name="_wrap_TpetraMultiVector_swap") use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 end subroutine @@ -1409,14 +1401,14 @@ subroutine swigc_TpetraMultiVector_swap(farg1, farg2) & subroutine swigc_delete_TpetraMultiVector(farg1) & bind(C, name="_wrap_delete_TpetraMultiVector") use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 end subroutine subroutine swigc_TpetraMultiVector_replaceGlobalValue(farg1, farg2, farg3, farg4) & bind(C, name="_wrap_TpetraMultiVector_replaceGlobalValue") use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 integer(C_LONG_LONG), intent(in) :: farg2 integer(C_SIZE_T), intent(in) :: farg3 @@ -1426,7 +1418,7 @@ subroutine swigc_TpetraMultiVector_replaceGlobalValue(farg1, farg2, farg3, farg4 subroutine swigc_TpetraMultiVector_sumIntoGlobalValue__SWIG_0(farg1, farg2, farg3, farg4, farg5) & bind(C, name="_wrap_TpetraMultiVector_sumIntoGlobalValue__SWIG_0") use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 integer(C_LONG_LONG), intent(in) :: farg2 integer(C_SIZE_T), intent(in) :: farg3 @@ -1437,7 +1429,7 @@ subroutine swigc_TpetraMultiVector_sumIntoGlobalValue__SWIG_0(farg1, farg2, farg subroutine swigc_TpetraMultiVector_sumIntoGlobalValue__SWIG_1(farg1, farg2, farg3, farg4) & bind(C, name="_wrap_TpetraMultiVector_sumIntoGlobalValue__SWIG_1") use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 integer(C_LONG_LONG), intent(in) :: farg2 integer(C_SIZE_T), intent(in) :: farg3 @@ -1447,7 +1439,7 @@ subroutine swigc_TpetraMultiVector_sumIntoGlobalValue__SWIG_1(farg1, farg2, farg subroutine swigc_TpetraMultiVector_replaceLocalValue(farg1, farg2, farg3, farg4) & bind(C, name="_wrap_TpetraMultiVector_replaceLocalValue") use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 integer(C_INT), intent(in) :: farg2 integer(C_SIZE_T), intent(in) :: farg3 @@ -1457,7 +1449,7 @@ subroutine swigc_TpetraMultiVector_replaceLocalValue(farg1, farg2, farg3, farg4) subroutine swigc_TpetraMultiVector_sumIntoLocalValue__SWIG_0(farg1, farg2, farg3, farg4, farg5) & bind(C, name="_wrap_TpetraMultiVector_sumIntoLocalValue__SWIG_0") use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 integer(C_INT), intent(in) :: farg2 integer(C_SIZE_T), intent(in) :: farg3 @@ -1468,7 +1460,7 @@ subroutine swigc_TpetraMultiVector_sumIntoLocalValue__SWIG_0(farg1, farg2, farg3 subroutine swigc_TpetraMultiVector_sumIntoLocalValue__SWIG_1(farg1, farg2, farg3, farg4) & bind(C, name="_wrap_TpetraMultiVector_sumIntoLocalValue__SWIG_1") use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 integer(C_INT), intent(in) :: farg2 integer(C_SIZE_T), intent(in) :: farg3 @@ -1478,7 +1470,7 @@ subroutine swigc_TpetraMultiVector_sumIntoLocalValue__SWIG_1(farg1, farg2, farg3 subroutine swigc_TpetraMultiVector_putScalar(farg1, farg2) & bind(C, name="_wrap_TpetraMultiVector_putScalar") use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 real(C_DOUBLE), intent(in) :: farg2 end subroutine @@ -1486,14 +1478,14 @@ subroutine swigc_TpetraMultiVector_putScalar(farg1, farg2) & subroutine swigc_TpetraMultiVector_randomize__SWIG_0(farg1) & bind(C, name="_wrap_TpetraMultiVector_randomize__SWIG_0") use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 end subroutine subroutine swigc_TpetraMultiVector_randomize__SWIG_1(farg1, farg2, farg3) & bind(C, name="_wrap_TpetraMultiVector_randomize__SWIG_1") use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 real(C_DOUBLE), intent(in) :: farg2 real(C_DOUBLE), intent(in) :: farg3 @@ -1502,7 +1494,7 @@ subroutine swigc_TpetraMultiVector_randomize__SWIG_1(farg1, farg2, farg3) & subroutine swigc_TpetraMultiVector_replaceMap(farg1, farg2) & bind(C, name="_wrap_TpetraMultiVector_replaceMap") use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 end subroutine @@ -1510,7 +1502,7 @@ subroutine swigc_TpetraMultiVector_replaceMap(farg1, farg2) & subroutine swigc_TpetraMultiVector_reduce(farg1) & bind(C, name="_wrap_TpetraMultiVector_reduce") use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 end subroutine @@ -1518,7 +1510,7 @@ function swigc_TpetraMultiVector_offsetView(farg1, farg2, farg3) & bind(C, name="_wrap_TpetraMultiVector_offsetView") & result(fresult) use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 integer(C_SIZE_T), intent(in) :: farg3 @@ -1529,7 +1521,7 @@ function swigc_TpetraMultiVector_offsetViewNonConst(farg1, farg2, farg3) & bind(C, name="_wrap_TpetraMultiVector_offsetViewNonConst") & result(fresult) use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 integer(C_SIZE_T), intent(in) :: farg3 @@ -1539,14 +1531,14 @@ function swigc_TpetraMultiVector_offsetViewNonConst(farg1, farg2, farg3) & subroutine swigc_TpetraMultiVector_sync_host(farg1) & bind(C, name="_wrap_TpetraMultiVector_sync_host") use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 end subroutine subroutine swigc_TpetraMultiVector_sync_device(farg1) & bind(C, name="_wrap_TpetraMultiVector_sync_device") use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 end subroutine @@ -1554,7 +1546,7 @@ function swigc_TpetraMultiVector_need_sync_host(farg1) & bind(C, name="_wrap_TpetraMultiVector_need_sync_host") & result(fresult) use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 logical(C_BOOL) :: fresult end function @@ -1563,7 +1555,7 @@ function swigc_TpetraMultiVector_need_sync_device(farg1) & bind(C, name="_wrap_TpetraMultiVector_need_sync_device") & result(fresult) use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 logical(C_BOOL) :: fresult end function @@ -1571,21 +1563,21 @@ function swigc_TpetraMultiVector_need_sync_device(farg1) & subroutine swigc_TpetraMultiVector_modify_device(farg1) & bind(C, name="_wrap_TpetraMultiVector_modify_device") use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 end subroutine subroutine swigc_TpetraMultiVector_modify_host(farg1) & bind(C, name="_wrap_TpetraMultiVector_modify_host") use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 end subroutine subroutine swigc_TpetraMultiVector_abs(farg1, farg2) & bind(C, name="_wrap_TpetraMultiVector_abs") use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 end subroutine @@ -1593,7 +1585,7 @@ subroutine swigc_TpetraMultiVector_abs(farg1, farg2) & subroutine swigc_TpetraMultiVector_reciprocal(farg1, farg2) & bind(C, name="_wrap_TpetraMultiVector_reciprocal") use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 end subroutine @@ -1601,7 +1593,7 @@ subroutine swigc_TpetraMultiVector_reciprocal(farg1, farg2) & subroutine swigc_TpetraMultiVector_scale__SWIG_0(farg1, farg2) & bind(C, name="_wrap_TpetraMultiVector_scale__SWIG_0") use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 real(C_DOUBLE), intent(in) :: farg2 end subroutine @@ -1609,7 +1601,7 @@ subroutine swigc_TpetraMultiVector_scale__SWIG_0(farg1, farg2) & subroutine swigc_TpetraMultiVector_scale__SWIG_1(farg1, farg2, farg3) & bind(C, name="_wrap_TpetraMultiVector_scale__SWIG_1") use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 real(C_DOUBLE), intent(in) :: farg2 type(SwigClassWrapper) :: farg3 @@ -1618,7 +1610,7 @@ subroutine swigc_TpetraMultiVector_scale__SWIG_1(farg1, farg2, farg3) & subroutine swigc_TpetraMultiVector_update__SWIG_0(farg1, farg2, farg3, farg4) & bind(C, name="_wrap_TpetraMultiVector_update__SWIG_0") use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 real(C_DOUBLE), intent(in) :: farg2 type(SwigClassWrapper) :: farg3 @@ -1628,7 +1620,7 @@ subroutine swigc_TpetraMultiVector_update__SWIG_0(farg1, farg2, farg3, farg4) & subroutine swigc_TpetraMultiVector_update__SWIG_1(farg1, farg2, farg3, farg4, farg5, farg6) & bind(C, name="_wrap_TpetraMultiVector_update__SWIG_1") use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 real(C_DOUBLE), intent(in) :: farg2 type(SwigClassWrapper) :: farg3 @@ -1640,7 +1632,7 @@ subroutine swigc_TpetraMultiVector_update__SWIG_1(farg1, farg2, farg3, farg4, fa subroutine swigc_TpetraMultiVector_multiply(farg1, farg2, farg3, farg4, farg5, farg6, farg7) & bind(C, name="_wrap_TpetraMultiVector_multiply") use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 integer(C_INT), intent(in) :: farg2 integer(C_INT), intent(in) :: farg3 @@ -1654,7 +1646,7 @@ function swigc_TpetraMultiVector_getNumVectors(farg1) & bind(C, name="_wrap_TpetraMultiVector_getNumVectors") & result(fresult) use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 integer(C_SIZE_T) :: fresult end function @@ -1663,7 +1655,7 @@ function swigc_TpetraMultiVector_getLocalLength(farg1) & bind(C, name="_wrap_TpetraMultiVector_getLocalLength") & result(fresult) use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 integer(C_SIZE_T) :: fresult end function @@ -1672,7 +1664,7 @@ function swigc_TpetraMultiVector_getGlobalLength(farg1) & bind(C, name="_wrap_TpetraMultiVector_getGlobalLength") & result(fresult) use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 integer(C_LONG) :: fresult end function @@ -1681,7 +1673,7 @@ function swigc_TpetraMultiVector_getStride(farg1) & bind(C, name="_wrap_TpetraMultiVector_getStride") & result(fresult) use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 integer(C_SIZE_T) :: fresult end function @@ -1690,7 +1682,7 @@ function swigc_TpetraMultiVector_isConstantStride(farg1) & bind(C, name="_wrap_TpetraMultiVector_isConstantStride") & result(fresult) use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 logical(C_BOOL) :: fresult end function @@ -1699,8 +1691,8 @@ function swigc_TpetraMultiVector_description(farg1) & bind(C, name="_wrap_TpetraMultiVector_description") & result(fresult) use, intrinsic :: ISO_C_BINDING -import :: SwigArrayWrapper -import :: SwigClassWrapper +import :: swigarraywrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 type(SwigArrayWrapper) :: fresult end function @@ -1708,7 +1700,7 @@ function swigc_TpetraMultiVector_description(farg1) & subroutine swigc_TpetraMultiVector_removeEmptyProcessesInPlace(farg1, farg2) & bind(C, name="_wrap_TpetraMultiVector_removeEmptyProcessesInPlace") use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 end subroutine @@ -1716,7 +1708,7 @@ subroutine swigc_TpetraMultiVector_removeEmptyProcessesInPlace(farg1, farg2) & subroutine swigc_TpetraMultiVector_setCopyOrView(farg1, farg2) & bind(C, name="_wrap_TpetraMultiVector_setCopyOrView") use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 integer(C_INT), intent(in) :: farg2 end subroutine @@ -1725,7 +1717,7 @@ function swigc_TpetraMultiVector_getCopyOrView(farg1) & bind(C, name="_wrap_TpetraMultiVector_getCopyOrView") & result(fresult) use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 integer(C_INT) :: fresult end function @@ -1734,7 +1726,7 @@ function swigc_TpetraMultiVector_isSameSize(farg1, farg2) & bind(C, name="_wrap_TpetraMultiVector_isSameSize") & result(fresult) use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 logical(C_BOOL) :: fresult @@ -1744,8 +1736,8 @@ function swigc_new_TpetraMultiVector__SWIG_8(farg1, farg2, farg3, farg4) & bind(C, name="_wrap_new_TpetraMultiVector__SWIG_8") & result(fresult) use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper -import :: SwigArrayWrapper +import :: swigclasswrapper +import :: swigarraywrapper type(SwigClassWrapper) :: farg1 type(SwigArrayWrapper) :: farg2 integer(C_SIZE_T), intent(in) :: farg3 @@ -1757,8 +1749,8 @@ function swigc_TpetraMultiVector_getData(farg1, farg2) & bind(C, name="_wrap_TpetraMultiVector_getData") & result(fresult) use, intrinsic :: ISO_C_BINDING -import :: SwigArrayWrapper -import :: SwigClassWrapper +import :: swigarraywrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 integer(C_SIZE_T), intent(in) :: farg2 type(SwigArrayWrapper) :: fresult @@ -1768,8 +1760,8 @@ function swigc_TpetraMultiVector_getDataNonConst(farg1, farg2) & bind(C, name="_wrap_TpetraMultiVector_getDataNonConst") & result(fresult) use, intrinsic :: ISO_C_BINDING -import :: SwigArrayWrapper -import :: SwigClassWrapper +import :: swigarraywrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 integer(C_SIZE_T), intent(in) :: farg2 type(SwigArrayWrapper) :: fresult @@ -1779,8 +1771,8 @@ function swigc_TpetraMultiVector_subCopy(farg1, farg2) & bind(C, name="_wrap_TpetraMultiVector_subCopy") & result(fresult) use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper -import :: SwigArrayWrapper +import :: swigclasswrapper +import :: swigarraywrapper type(SwigClassWrapper) :: farg1 type(SwigArrayWrapper) :: farg2 type(SwigClassWrapper) :: fresult @@ -1790,8 +1782,8 @@ function swigc_TpetraMultiVector_subView(farg1, farg2) & bind(C, name="_wrap_TpetraMultiVector_subView") & result(fresult) use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper -import :: SwigArrayWrapper +import :: swigclasswrapper +import :: swigarraywrapper type(SwigClassWrapper) :: farg1 type(SwigArrayWrapper) :: farg2 type(SwigClassWrapper) :: fresult @@ -1801,8 +1793,8 @@ function swigc_TpetraMultiVector_subViewNonConst(farg1, farg2) & bind(C, name="_wrap_TpetraMultiVector_subViewNonConst") & result(fresult) use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper -import :: SwigArrayWrapper +import :: swigclasswrapper +import :: swigarraywrapper type(SwigClassWrapper) :: farg1 type(SwigArrayWrapper) :: farg2 type(SwigClassWrapper) :: fresult @@ -1811,8 +1803,8 @@ function swigc_TpetraMultiVector_subViewNonConst(farg1, farg2) & subroutine swigc_TpetraMultiVector_dot(farg1, farg2, farg3) & bind(C, name="_wrap_TpetraMultiVector_dot") use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper -import :: SwigArrayWrapper +import :: swigclasswrapper +import :: swigarraywrapper type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 type(SwigArrayWrapper) :: farg3 @@ -1821,8 +1813,8 @@ subroutine swigc_TpetraMultiVector_dot(farg1, farg2, farg3) & subroutine swigc_TpetraMultiVector_norm1(farg1, farg2) & bind(C, name="_wrap_TpetraMultiVector_norm1") use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper -import :: SwigArrayWrapper +import :: swigclasswrapper +import :: swigarraywrapper type(SwigClassWrapper) :: farg1 type(SwigArrayWrapper) :: farg2 end subroutine @@ -1830,8 +1822,8 @@ subroutine swigc_TpetraMultiVector_norm1(farg1, farg2) & subroutine swigc_TpetraMultiVector_norm2(farg1, farg2) & bind(C, name="_wrap_TpetraMultiVector_norm2") use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper -import :: SwigArrayWrapper +import :: swigclasswrapper +import :: swigarraywrapper type(SwigClassWrapper) :: farg1 type(SwigArrayWrapper) :: farg2 end subroutine @@ -1839,8 +1831,8 @@ subroutine swigc_TpetraMultiVector_norm2(farg1, farg2) & subroutine swigc_TpetraMultiVector_normInf(farg1, farg2) & bind(C, name="_wrap_TpetraMultiVector_normInf") use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper -import :: SwigArrayWrapper +import :: swigclasswrapper +import :: swigarraywrapper type(SwigClassWrapper) :: farg1 type(SwigArrayWrapper) :: farg2 end subroutine @@ -1848,8 +1840,8 @@ subroutine swigc_TpetraMultiVector_normInf(farg1, farg2) & subroutine swigc_TpetraMultiVector_scale__SWIG_2(farg1, farg2) & bind(C, name="_wrap_TpetraMultiVector_scale__SWIG_2") use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper -import :: SwigArrayWrapper +import :: swigclasswrapper +import :: swigarraywrapper type(SwigClassWrapper) :: farg1 type(SwigArrayWrapper) :: farg2 end subroutine @@ -1857,8 +1849,8 @@ subroutine swigc_TpetraMultiVector_scale__SWIG_2(farg1, farg2) & subroutine swigc_TpetraMultiVector_meanValue(farg1, farg2) & bind(C, name="_wrap_TpetraMultiVector_meanValue") use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper -import :: SwigArrayWrapper +import :: swigclasswrapper +import :: swigarraywrapper type(SwigClassWrapper) :: farg1 type(SwigArrayWrapper) :: farg2 end subroutine @@ -1866,8 +1858,8 @@ subroutine swigc_TpetraMultiVector_meanValue(farg1, farg2) & subroutine swigc_TpetraMultiVector_get1dCopy(farg1, farg2, farg3) & bind(C, name="_wrap_TpetraMultiVector_get1dCopy") use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper -import :: SwigArrayWrapper +import :: swigclasswrapper +import :: swigarraywrapper type(SwigClassWrapper) :: farg1 type(SwigArrayWrapper) :: farg2 integer(C_SIZE_T), intent(in) :: farg3 @@ -1877,8 +1869,8 @@ function swigc_TpetraMultiVector_get1dView(farg1) & bind(C, name="_wrap_TpetraMultiVector_get1dView") & result(fresult) use, intrinsic :: ISO_C_BINDING -import :: SwigArrayWrapper -import :: SwigClassWrapper +import :: swigarraywrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 type(SwigArrayWrapper) :: fresult end function @@ -1887,8 +1879,8 @@ function swigc_TpetraMultiVector_get1dViewNonConst(farg1) & bind(C, name="_wrap_TpetraMultiVector_get1dViewNonConst") & result(fresult) use, intrinsic :: ISO_C_BINDING -import :: SwigArrayWrapper -import :: SwigClassWrapper +import :: swigarraywrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 type(SwigArrayWrapper) :: fresult end function @@ -1896,7 +1888,7 @@ function swigc_TpetraMultiVector_get1dViewNonConst(farg1) & subroutine swigc_TpetraMultiVector_doImport__SWIG_0(farg1, farg2, farg3, farg4) & bind(C, name="_wrap_TpetraMultiVector_doImport__SWIG_0") use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 type(SwigClassWrapper) :: farg3 @@ -1906,7 +1898,7 @@ subroutine swigc_TpetraMultiVector_doImport__SWIG_0(farg1, farg2, farg3, farg4) subroutine swigc_TpetraMultiVector_doImport__SWIG_1(farg1, farg2, farg3, farg4) & bind(C, name="_wrap_TpetraMultiVector_doImport__SWIG_1") use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 type(SwigClassWrapper) :: farg3 @@ -1916,7 +1908,7 @@ subroutine swigc_TpetraMultiVector_doImport__SWIG_1(farg1, farg2, farg3, farg4) subroutine swigc_TpetraMultiVector_doExport__SWIG_0(farg1, farg2, farg3, farg4) & bind(C, name="_wrap_TpetraMultiVector_doExport__SWIG_0") use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 type(SwigClassWrapper) :: farg3 @@ -1926,7 +1918,7 @@ subroutine swigc_TpetraMultiVector_doExport__SWIG_0(farg1, farg2, farg3, farg4) subroutine swigc_TpetraMultiVector_doExport__SWIG_1(farg1, farg2, farg3, farg4) & bind(C, name="_wrap_TpetraMultiVector_doExport__SWIG_1") use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 type(SwigClassWrapper) :: farg3 @@ -1937,7 +1929,7 @@ function swigc_TpetraMultiVector_getMap(farg1) & bind(C, name="_wrap_TpetraMultiVector_getMap") & result(fresult) use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: fresult end function @@ -1952,7 +1944,7 @@ subroutine swigc_assignment_TpetraMultiVector(self, other) & subroutine swigc_delete_TpetraOperator(farg1) & bind(C, name="_wrap_delete_TpetraOperator") use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 end subroutine @@ -1967,7 +1959,7 @@ function swigc_ForTpetraOperator_fhandle(farg1) & bind(C, name="_wrap_ForTpetraOperator_fhandle") & result(fresult) use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 type(C_PTR) :: fresult end function @@ -1975,7 +1967,7 @@ function swigc_ForTpetraOperator_fhandle(farg1) & subroutine swigc_ForTpetraOperator_init(farg1, farg2) & bind(C, name="_wrap_ForTpetraOperator_init") use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 type(C_PTR), value :: farg2 end subroutine @@ -1984,7 +1976,7 @@ function swigc_new_ForTpetraOperator() & bind(C, name="_wrap_new_ForTpetraOperator") & result(fresult) use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: fresult end function @@ -1992,7 +1984,7 @@ function swigc_ForTpetraOperator_getDomainMap(farg1) & bind(C, name="_wrap_ForTpetraOperator_getDomainMap") & result(fresult) use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: fresult end function @@ -2001,7 +1993,7 @@ function swigc_ForTpetraOperator_getRangeMap(farg1) & bind(C, name="_wrap_ForTpetraOperator_getRangeMap") & result(fresult) use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: fresult end function @@ -2009,7 +2001,7 @@ function swigc_ForTpetraOperator_getRangeMap(farg1) & subroutine swigc_ForTpetraOperator_apply(farg1, farg2, farg3, farg4, farg5, farg6) & bind(C, name="_wrap_ForTpetraOperator_apply") use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 type(SwigClassWrapper) :: farg3 @@ -2021,7 +2013,7 @@ subroutine swigc_ForTpetraOperator_apply(farg1, farg2, farg3, farg4, farg5, farg subroutine swigc_delete_ForTpetraOperator(farg1) & bind(C, name="_wrap_delete_ForTpetraOperator") use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 end subroutine @@ -2035,7 +2027,7 @@ subroutine swigc_assignment_ForTpetraOperator(self, other) & subroutine swigc_RowInfo_localRow_set(farg1, farg2) & bind(C, name="_wrap_RowInfo_localRow_set") use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 integer(C_SIZE_T), intent(in) :: farg2 end subroutine @@ -2044,7 +2036,7 @@ function swigc_RowInfo_localRow_get(farg1) & bind(C, name="_wrap_RowInfo_localRow_get") & result(fresult) use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 integer(C_SIZE_T) :: fresult end function @@ -2052,7 +2044,7 @@ function swigc_RowInfo_localRow_get(farg1) & subroutine swigc_RowInfo_allocSize_set(farg1, farg2) & bind(C, name="_wrap_RowInfo_allocSize_set") use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 integer(C_SIZE_T), intent(in) :: farg2 end subroutine @@ -2061,7 +2053,7 @@ function swigc_RowInfo_allocSize_get(farg1) & bind(C, name="_wrap_RowInfo_allocSize_get") & result(fresult) use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 integer(C_SIZE_T) :: fresult end function @@ -2069,7 +2061,7 @@ function swigc_RowInfo_allocSize_get(farg1) & subroutine swigc_RowInfo_numEntries_set(farg1, farg2) & bind(C, name="_wrap_RowInfo_numEntries_set") use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 integer(C_SIZE_T), intent(in) :: farg2 end subroutine @@ -2078,7 +2070,7 @@ function swigc_RowInfo_numEntries_get(farg1) & bind(C, name="_wrap_RowInfo_numEntries_get") & result(fresult) use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 integer(C_SIZE_T) :: fresult end function @@ -2086,7 +2078,7 @@ function swigc_RowInfo_numEntries_get(farg1) & subroutine swigc_RowInfo_offset1D_set(farg1, farg2) & bind(C, name="_wrap_RowInfo_offset1D_set") use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 integer(C_SIZE_T), intent(in) :: farg2 end subroutine @@ -2095,7 +2087,7 @@ function swigc_RowInfo_offset1D_get(farg1) & bind(C, name="_wrap_RowInfo_offset1D_get") & result(fresult) use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 integer(C_SIZE_T) :: fresult end function @@ -2104,14 +2096,14 @@ function swigc_new_RowInfo() & bind(C, name="_wrap_new_RowInfo") & result(fresult) use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: fresult end function subroutine swigc_delete_RowInfo(farg1) & bind(C, name="_wrap_delete_RowInfo") use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 end subroutine @@ -2126,7 +2118,7 @@ function swigc_new_TpetraCrsGraph__SWIG_0(farg1, farg2, farg3, farg4) & bind(C, name="_wrap_new_TpetraCrsGraph__SWIG_0") & result(fresult) use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 integer(C_SIZE_T), intent(in) :: farg2 integer(C_INT), intent(in) :: farg3 @@ -2138,7 +2130,7 @@ function swigc_new_TpetraCrsGraph__SWIG_1(farg1, farg2, farg3) & bind(C, name="_wrap_new_TpetraCrsGraph__SWIG_1") & result(fresult) use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 integer(C_SIZE_T), intent(in) :: farg2 integer(C_INT), intent(in) :: farg3 @@ -2149,7 +2141,7 @@ function swigc_new_TpetraCrsGraph__SWIG_2(farg1, farg2) & bind(C, name="_wrap_new_TpetraCrsGraph__SWIG_2") & result(fresult) use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 integer(C_SIZE_T), intent(in) :: farg2 type(SwigClassWrapper) :: fresult @@ -2159,7 +2151,7 @@ function swigc_new_TpetraCrsGraph__SWIG_3(farg1, farg2, farg3, farg4, farg5) & bind(C, name="_wrap_new_TpetraCrsGraph__SWIG_3") & result(fresult) use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 integer(C_SIZE_T), intent(in) :: farg3 @@ -2172,7 +2164,7 @@ function swigc_new_TpetraCrsGraph__SWIG_4(farg1, farg2, farg3, farg4) & bind(C, name="_wrap_new_TpetraCrsGraph__SWIG_4") & result(fresult) use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 integer(C_SIZE_T), intent(in) :: farg3 @@ -2184,7 +2176,7 @@ function swigc_new_TpetraCrsGraph__SWIG_5(farg1, farg2, farg3) & bind(C, name="_wrap_new_TpetraCrsGraph__SWIG_5") & result(fresult) use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 integer(C_SIZE_T), intent(in) :: farg3 @@ -2194,14 +2186,14 @@ function swigc_new_TpetraCrsGraph__SWIG_5(farg1, farg2, farg3) & subroutine swigc_delete_TpetraCrsGraph(farg1) & bind(C, name="_wrap_delete_TpetraCrsGraph") use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 end subroutine subroutine swigc_TpetraCrsGraph_swap(farg1, farg2) & bind(C, name="_wrap_TpetraCrsGraph_swap") use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 end subroutine @@ -2210,7 +2202,7 @@ function swigc_TpetraCrsGraph_isIdenticalTo(farg1, farg2) & bind(C, name="_wrap_TpetraCrsGraph_isIdenticalTo") & result(fresult) use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 logical(C_BOOL) :: fresult @@ -2219,7 +2211,7 @@ function swigc_TpetraCrsGraph_isIdenticalTo(farg1, farg2) & subroutine swigc_TpetraCrsGraph_setParameterList(farg1, farg2) & bind(C, name="_wrap_TpetraCrsGraph_setParameterList") use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 end subroutine @@ -2228,7 +2220,7 @@ function swigc_TpetraCrsGraph_getValidParameters(farg1) & bind(C, name="_wrap_TpetraCrsGraph_getValidParameters") & result(fresult) use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: fresult end function @@ -2236,7 +2228,7 @@ function swigc_TpetraCrsGraph_getValidParameters(farg1) & subroutine swigc_TpetraCrsGraph_insertGlobalIndices__SWIG_0(farg1, farg2, farg3, farg4) & bind(C, name="_wrap_TpetraCrsGraph_insertGlobalIndices__SWIG_0") use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 integer(C_LONG_LONG), intent(in) :: farg2 integer(C_INT), intent(in) :: farg3 @@ -2246,7 +2238,7 @@ subroutine swigc_TpetraCrsGraph_insertGlobalIndices__SWIG_0(farg1, farg2, farg3, subroutine swigc_TpetraCrsGraph_removeLocalIndices(farg1, farg2) & bind(C, name="_wrap_TpetraCrsGraph_removeLocalIndices") use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 integer(C_INT), intent(in) :: farg2 end subroutine @@ -2254,14 +2246,14 @@ subroutine swigc_TpetraCrsGraph_removeLocalIndices(farg1, farg2) & subroutine swigc_TpetraCrsGraph_globalAssemble(farg1) & bind(C, name="_wrap_TpetraCrsGraph_globalAssemble") use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 end subroutine subroutine swigc_TpetraCrsGraph_resumeFill__SWIG_0(farg1, farg2) & bind(C, name="_wrap_TpetraCrsGraph_resumeFill__SWIG_0") use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 end subroutine @@ -2269,14 +2261,14 @@ subroutine swigc_TpetraCrsGraph_resumeFill__SWIG_0(farg1, farg2) & subroutine swigc_TpetraCrsGraph_resumeFill__SWIG_1(farg1) & bind(C, name="_wrap_TpetraCrsGraph_resumeFill__SWIG_1") use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 end subroutine subroutine swigc_TpetraCrsGraph_fillComplete__SWIG_0(farg1, farg2, farg3, farg4) & bind(C, name="_wrap_TpetraCrsGraph_fillComplete__SWIG_0") use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 type(SwigClassWrapper) :: farg3 @@ -2286,7 +2278,7 @@ subroutine swigc_TpetraCrsGraph_fillComplete__SWIG_0(farg1, farg2, farg3, farg4) subroutine swigc_TpetraCrsGraph_fillComplete__SWIG_1(farg1, farg2, farg3) & bind(C, name="_wrap_TpetraCrsGraph_fillComplete__SWIG_1") use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 type(SwigClassWrapper) :: farg3 @@ -2295,7 +2287,7 @@ subroutine swigc_TpetraCrsGraph_fillComplete__SWIG_1(farg1, farg2, farg3) & subroutine swigc_TpetraCrsGraph_fillComplete__SWIG_2(farg1, farg2) & bind(C, name="_wrap_TpetraCrsGraph_fillComplete__SWIG_2") use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 end subroutine @@ -2303,14 +2295,14 @@ subroutine swigc_TpetraCrsGraph_fillComplete__SWIG_2(farg1, farg2) & subroutine swigc_TpetraCrsGraph_fillComplete__SWIG_3(farg1) & bind(C, name="_wrap_TpetraCrsGraph_fillComplete__SWIG_3") use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 end subroutine subroutine swigc_TpetraCrsGraph_expertStaticFillComplete__SWIG_0(farg1, farg2, farg3, farg4, farg5, farg6) & bind(C, name="_wrap_TpetraCrsGraph_expertStaticFillComplete__SWIG_0") use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 type(SwigClassWrapper) :: farg3 @@ -2322,7 +2314,7 @@ subroutine swigc_TpetraCrsGraph_expertStaticFillComplete__SWIG_0(farg1, farg2, f subroutine swigc_TpetraCrsGraph_expertStaticFillComplete__SWIG_1(farg1, farg2, farg3, farg4, farg5) & bind(C, name="_wrap_TpetraCrsGraph_expertStaticFillComplete__SWIG_1") use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 type(SwigClassWrapper) :: farg3 @@ -2333,7 +2325,7 @@ subroutine swigc_TpetraCrsGraph_expertStaticFillComplete__SWIG_1(farg1, farg2, f subroutine swigc_TpetraCrsGraph_expertStaticFillComplete__SWIG_2(farg1, farg2, farg3, farg4) & bind(C, name="_wrap_TpetraCrsGraph_expertStaticFillComplete__SWIG_2") use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 type(SwigClassWrapper) :: farg3 @@ -2343,7 +2335,7 @@ subroutine swigc_TpetraCrsGraph_expertStaticFillComplete__SWIG_2(farg1, farg2, f subroutine swigc_TpetraCrsGraph_expertStaticFillComplete__SWIG_3(farg1, farg2, farg3) & bind(C, name="_wrap_TpetraCrsGraph_expertStaticFillComplete__SWIG_3") use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 type(SwigClassWrapper) :: farg3 @@ -2353,7 +2345,7 @@ function swigc_TpetraCrsGraph_getComm(farg1) & bind(C, name="_wrap_TpetraCrsGraph_getComm") & result(fresult) use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: fresult end function @@ -2362,7 +2354,7 @@ function swigc_TpetraCrsGraph_getRowMap(farg1) & bind(C, name="_wrap_TpetraCrsGraph_getRowMap") & result(fresult) use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: fresult end function @@ -2371,7 +2363,7 @@ function swigc_TpetraCrsGraph_getColMap(farg1) & bind(C, name="_wrap_TpetraCrsGraph_getColMap") & result(fresult) use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: fresult end function @@ -2380,7 +2372,7 @@ function swigc_TpetraCrsGraph_getDomainMap(farg1) & bind(C, name="_wrap_TpetraCrsGraph_getDomainMap") & result(fresult) use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: fresult end function @@ -2389,7 +2381,7 @@ function swigc_TpetraCrsGraph_getRangeMap(farg1) & bind(C, name="_wrap_TpetraCrsGraph_getRangeMap") & result(fresult) use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: fresult end function @@ -2398,7 +2390,7 @@ function swigc_TpetraCrsGraph_getImporter(farg1) & bind(C, name="_wrap_TpetraCrsGraph_getImporter") & result(fresult) use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: fresult end function @@ -2407,7 +2399,7 @@ function swigc_TpetraCrsGraph_getExporter(farg1) & bind(C, name="_wrap_TpetraCrsGraph_getExporter") & result(fresult) use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: fresult end function @@ -2416,7 +2408,7 @@ function swigc_TpetraCrsGraph_getGlobalNumRows(farg1) & bind(C, name="_wrap_TpetraCrsGraph_getGlobalNumRows") & result(fresult) use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 integer(C_LONG) :: fresult end function @@ -2425,7 +2417,7 @@ function swigc_TpetraCrsGraph_getGlobalNumCols(farg1) & bind(C, name="_wrap_TpetraCrsGraph_getGlobalNumCols") & result(fresult) use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 integer(C_LONG) :: fresult end function @@ -2434,7 +2426,7 @@ function swigc_TpetraCrsGraph_getNodeNumRows(farg1) & bind(C, name="_wrap_TpetraCrsGraph_getNodeNumRows") & result(fresult) use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 integer(C_SIZE_T) :: fresult end function @@ -2443,7 +2435,7 @@ function swigc_TpetraCrsGraph_getNodeNumCols(farg1) & bind(C, name="_wrap_TpetraCrsGraph_getNodeNumCols") & result(fresult) use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 integer(C_SIZE_T) :: fresult end function @@ -2452,7 +2444,7 @@ function swigc_TpetraCrsGraph_getGlobalNumEntries(farg1) & bind(C, name="_wrap_TpetraCrsGraph_getGlobalNumEntries") & result(fresult) use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 integer(C_LONG) :: fresult end function @@ -2461,7 +2453,7 @@ function swigc_TpetraCrsGraph_getNodeNumEntries(farg1) & bind(C, name="_wrap_TpetraCrsGraph_getNodeNumEntries") & result(fresult) use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 integer(C_SIZE_T) :: fresult end function @@ -2470,7 +2462,7 @@ function swigc_TpetraCrsGraph_getNumEntriesInGlobalRow(farg1, farg2) & bind(C, name="_wrap_TpetraCrsGraph_getNumEntriesInGlobalRow") & result(fresult) use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 integer(C_LONG_LONG), intent(in) :: farg2 integer(C_SIZE_T) :: fresult @@ -2480,7 +2472,7 @@ function swigc_TpetraCrsGraph_getNumEntriesInLocalRow(farg1, farg2) & bind(C, name="_wrap_TpetraCrsGraph_getNumEntriesInLocalRow") & result(fresult) use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 integer(C_INT), intent(in) :: farg2 integer(C_SIZE_T) :: fresult @@ -2490,7 +2482,7 @@ function swigc_TpetraCrsGraph_getNodeAllocationSize(farg1) & bind(C, name="_wrap_TpetraCrsGraph_getNodeAllocationSize") & result(fresult) use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 integer(C_SIZE_T) :: fresult end function @@ -2499,7 +2491,7 @@ function swigc_TpetraCrsGraph_getNumAllocatedEntriesInGlobalRow(farg1, farg2) & bind(C, name="_wrap_TpetraCrsGraph_getNumAllocatedEntriesInGlobalRow") & result(fresult) use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 integer(C_LONG_LONG), intent(in) :: farg2 integer(C_SIZE_T) :: fresult @@ -2509,7 +2501,7 @@ function swigc_TpetraCrsGraph_getNumAllocatedEntriesInLocalRow(farg1, farg2) & bind(C, name="_wrap_TpetraCrsGraph_getNumAllocatedEntriesInLocalRow") & result(fresult) use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 integer(C_INT), intent(in) :: farg2 integer(C_SIZE_T) :: fresult @@ -2519,7 +2511,7 @@ function swigc_TpetraCrsGraph_getGlobalNumDiags(farg1) & bind(C, name="_wrap_TpetraCrsGraph_getGlobalNumDiags") & result(fresult) use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 integer(C_LONG) :: fresult end function @@ -2528,7 +2520,7 @@ function swigc_TpetraCrsGraph_getGlobalNumDiagsImpl(farg1) & bind(C, name="_wrap_TpetraCrsGraph_getGlobalNumDiagsImpl") & result(fresult) use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 integer(C_LONG) :: fresult end function @@ -2537,7 +2529,7 @@ function swigc_TpetraCrsGraph_getNodeNumDiags(farg1) & bind(C, name="_wrap_TpetraCrsGraph_getNodeNumDiags") & result(fresult) use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 integer(C_SIZE_T) :: fresult end function @@ -2546,7 +2538,7 @@ function swigc_TpetraCrsGraph_getNodeNumDiagsImpl(farg1) & bind(C, name="_wrap_TpetraCrsGraph_getNodeNumDiagsImpl") & result(fresult) use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 integer(C_SIZE_T) :: fresult end function @@ -2555,7 +2547,7 @@ function swigc_TpetraCrsGraph_getGlobalMaxNumRowEntries(farg1) & bind(C, name="_wrap_TpetraCrsGraph_getGlobalMaxNumRowEntries") & result(fresult) use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 integer(C_SIZE_T) :: fresult end function @@ -2564,7 +2556,7 @@ function swigc_TpetraCrsGraph_getNodeMaxNumRowEntries(farg1) & bind(C, name="_wrap_TpetraCrsGraph_getNodeMaxNumRowEntries") & result(fresult) use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 integer(C_SIZE_T) :: fresult end function @@ -2573,7 +2565,7 @@ function swigc_TpetraCrsGraph_hasColMap(farg1) & bind(C, name="_wrap_TpetraCrsGraph_hasColMap") & result(fresult) use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 logical(C_BOOL) :: fresult end function @@ -2582,7 +2574,7 @@ function swigc_TpetraCrsGraph_isLowerTriangularImpl(farg1) & bind(C, name="_wrap_TpetraCrsGraph_isLowerTriangularImpl") & result(fresult) use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 logical(C_BOOL) :: fresult end function @@ -2591,7 +2583,7 @@ function swigc_TpetraCrsGraph_isLowerTriangular(farg1) & bind(C, name="_wrap_TpetraCrsGraph_isLowerTriangular") & result(fresult) use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 logical(C_BOOL) :: fresult end function @@ -2600,7 +2592,7 @@ function swigc_TpetraCrsGraph_isUpperTriangularImpl(farg1) & bind(C, name="_wrap_TpetraCrsGraph_isUpperTriangularImpl") & result(fresult) use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 logical(C_BOOL) :: fresult end function @@ -2609,7 +2601,7 @@ function swigc_TpetraCrsGraph_isUpperTriangular(farg1) & bind(C, name="_wrap_TpetraCrsGraph_isUpperTriangular") & result(fresult) use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 logical(C_BOOL) :: fresult end function @@ -2618,7 +2610,7 @@ function swigc_TpetraCrsGraph_isLocallyIndexed(farg1) & bind(C, name="_wrap_TpetraCrsGraph_isLocallyIndexed") & result(fresult) use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 logical(C_BOOL) :: fresult end function @@ -2627,7 +2619,7 @@ function swigc_TpetraCrsGraph_isGloballyIndexed(farg1) & bind(C, name="_wrap_TpetraCrsGraph_isGloballyIndexed") & result(fresult) use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 logical(C_BOOL) :: fresult end function @@ -2636,7 +2628,7 @@ function swigc_TpetraCrsGraph_isFillComplete(farg1) & bind(C, name="_wrap_TpetraCrsGraph_isFillComplete") & result(fresult) use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 logical(C_BOOL) :: fresult end function @@ -2645,7 +2637,7 @@ function swigc_TpetraCrsGraph_isFillActive(farg1) & bind(C, name="_wrap_TpetraCrsGraph_isFillActive") & result(fresult) use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 logical(C_BOOL) :: fresult end function @@ -2654,7 +2646,7 @@ function swigc_TpetraCrsGraph_isSorted(farg1) & bind(C, name="_wrap_TpetraCrsGraph_isSorted") & result(fresult) use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 logical(C_BOOL) :: fresult end function @@ -2663,7 +2655,7 @@ function swigc_TpetraCrsGraph_isStorageOptimized(farg1) & bind(C, name="_wrap_TpetraCrsGraph_isStorageOptimized") & result(fresult) use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 logical(C_BOOL) :: fresult end function @@ -2672,7 +2664,7 @@ function swigc_TpetraCrsGraph_getProfileType(farg1) & bind(C, name="_wrap_TpetraCrsGraph_getProfileType") & result(fresult) use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 integer(C_INT) :: fresult end function @@ -2681,7 +2673,7 @@ function swigc_TpetraCrsGraph_supportsRowViews(farg1) & bind(C, name="_wrap_TpetraCrsGraph_supportsRowViews") & result(fresult) use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 logical(C_BOOL) :: fresult end function @@ -2690,8 +2682,8 @@ function swigc_TpetraCrsGraph_description(farg1) & bind(C, name="_wrap_TpetraCrsGraph_description") & result(fresult) use, intrinsic :: ISO_C_BINDING -import :: SwigArrayWrapper -import :: SwigClassWrapper +import :: swigarraywrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 type(SwigArrayWrapper) :: fresult end function @@ -2699,7 +2691,7 @@ function swigc_TpetraCrsGraph_description(farg1) & subroutine swigc_TpetraCrsGraph_replaceColMap(farg1, farg2) & bind(C, name="_wrap_TpetraCrsGraph_replaceColMap") use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 end subroutine @@ -2707,7 +2699,7 @@ subroutine swigc_TpetraCrsGraph_replaceColMap(farg1, farg2) & subroutine swigc_TpetraCrsGraph_reindexColumns__SWIG_0(farg1, farg2, farg3, farg4) & bind(C, name="_wrap_TpetraCrsGraph_reindexColumns__SWIG_0") use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 type(SwigClassWrapper) :: farg3 @@ -2717,7 +2709,7 @@ subroutine swigc_TpetraCrsGraph_reindexColumns__SWIG_0(farg1, farg2, farg3, farg subroutine swigc_TpetraCrsGraph_reindexColumns__SWIG_1(farg1, farg2, farg3) & bind(C, name="_wrap_TpetraCrsGraph_reindexColumns__SWIG_1") use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 type(SwigClassWrapper) :: farg3 @@ -2726,7 +2718,7 @@ subroutine swigc_TpetraCrsGraph_reindexColumns__SWIG_1(farg1, farg2, farg3) & subroutine swigc_TpetraCrsGraph_reindexColumns__SWIG_2(farg1, farg2) & bind(C, name="_wrap_TpetraCrsGraph_reindexColumns__SWIG_2") use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 end subroutine @@ -2734,7 +2726,7 @@ subroutine swigc_TpetraCrsGraph_reindexColumns__SWIG_2(farg1, farg2) & subroutine swigc_TpetraCrsGraph_replaceDomainMapAndImporter(farg1, farg2, farg3) & bind(C, name="_wrap_TpetraCrsGraph_replaceDomainMapAndImporter") use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 type(SwigClassWrapper) :: farg3 @@ -2743,7 +2735,7 @@ subroutine swigc_TpetraCrsGraph_replaceDomainMapAndImporter(farg1, farg2, farg3) subroutine swigc_TpetraCrsGraph_removeEmptyProcessesInPlace(farg1, farg2) & bind(C, name="_wrap_TpetraCrsGraph_removeEmptyProcessesInPlace") use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 end subroutine @@ -2751,7 +2743,7 @@ subroutine swigc_TpetraCrsGraph_removeEmptyProcessesInPlace(farg1, farg2) & subroutine swigc_TpetraCrsGraph_importAndFillComplete__SWIG_0(farg1, farg2, farg3, farg4, farg5, farg6) & bind(C, name="_wrap_TpetraCrsGraph_importAndFillComplete__SWIG_0") use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 type(SwigClassWrapper) :: farg3 @@ -2763,7 +2755,7 @@ subroutine swigc_TpetraCrsGraph_importAndFillComplete__SWIG_0(farg1, farg2, farg subroutine swigc_TpetraCrsGraph_importAndFillComplete__SWIG_1(farg1, farg2, farg3, farg4, farg5) & bind(C, name="_wrap_TpetraCrsGraph_importAndFillComplete__SWIG_1") use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 type(SwigClassWrapper) :: farg3 @@ -2774,7 +2766,7 @@ subroutine swigc_TpetraCrsGraph_importAndFillComplete__SWIG_1(farg1, farg2, farg subroutine swigc_TpetraCrsGraph_importAndFillComplete__SWIG_2(farg1, farg2, farg3, farg4, farg5, farg6, farg7) & bind(C, name="_wrap_TpetraCrsGraph_importAndFillComplete__SWIG_2") use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 type(SwigClassWrapper) :: farg3 @@ -2787,7 +2779,7 @@ subroutine swigc_TpetraCrsGraph_importAndFillComplete__SWIG_2(farg1, farg2, farg subroutine swigc_TpetraCrsGraph_exportAndFillComplete__SWIG_0(farg1, farg2, farg3, farg4, farg5, farg6) & bind(C, name="_wrap_TpetraCrsGraph_exportAndFillComplete__SWIG_0") use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 type(SwigClassWrapper) :: farg3 @@ -2799,7 +2791,7 @@ subroutine swigc_TpetraCrsGraph_exportAndFillComplete__SWIG_0(farg1, farg2, farg subroutine swigc_TpetraCrsGraph_exportAndFillComplete__SWIG_1(farg1, farg2, farg3, farg4, farg5) & bind(C, name="_wrap_TpetraCrsGraph_exportAndFillComplete__SWIG_1") use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 type(SwigClassWrapper) :: farg3 @@ -2810,7 +2802,7 @@ subroutine swigc_TpetraCrsGraph_exportAndFillComplete__SWIG_1(farg1, farg2, farg subroutine swigc_TpetraCrsGraph_exportAndFillComplete__SWIG_2(farg1, farg2, farg3, farg4) & bind(C, name="_wrap_TpetraCrsGraph_exportAndFillComplete__SWIG_2") use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 type(SwigClassWrapper) :: farg3 @@ -2820,7 +2812,7 @@ subroutine swigc_TpetraCrsGraph_exportAndFillComplete__SWIG_2(farg1, farg2, farg subroutine swigc_TpetraCrsGraph_exportAndFillComplete__SWIG_3(farg1, farg2, farg3) & bind(C, name="_wrap_TpetraCrsGraph_exportAndFillComplete__SWIG_3") use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 type(SwigClassWrapper) :: farg3 @@ -2829,7 +2821,7 @@ subroutine swigc_TpetraCrsGraph_exportAndFillComplete__SWIG_3(farg1, farg2, farg subroutine swigc_TpetraCrsGraph_exportAndFillComplete__SWIG_4(farg1, farg2, farg3, farg4, farg5, farg6, farg7) & bind(C, name="_wrap_TpetraCrsGraph_exportAndFillComplete__SWIG_4") use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 type(SwigClassWrapper) :: farg3 @@ -2843,7 +2835,7 @@ function swigc_TpetraCrsGraph_haveGlobalConstants(farg1) & bind(C, name="_wrap_TpetraCrsGraph_haveGlobalConstants") & result(fresult) use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 logical(C_BOOL) :: fresult end function @@ -2851,7 +2843,7 @@ function swigc_TpetraCrsGraph_haveGlobalConstants(farg1) & subroutine swigc_TpetraCrsGraph_computeGlobalConstants(farg1, farg2) & bind(C, name="_wrap_TpetraCrsGraph_computeGlobalConstants") use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 logical(C_BOOL), intent(in) :: farg2 end subroutine @@ -2860,8 +2852,8 @@ function swigc_new_TpetraCrsGraph__SWIG_6(farg1, farg2, farg3, farg4) & bind(C, name="_wrap_new_TpetraCrsGraph__SWIG_6") & result(fresult) use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper -import :: SwigArrayWrapper +import :: swigclasswrapper +import :: swigarraywrapper type(SwigClassWrapper) :: farg1 type(SwigArrayWrapper) :: farg2 integer(C_INT), intent(in) :: farg3 @@ -2873,8 +2865,8 @@ function swigc_new_TpetraCrsGraph__SWIG_7(farg1, farg2, farg3) & bind(C, name="_wrap_new_TpetraCrsGraph__SWIG_7") & result(fresult) use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper -import :: SwigArrayWrapper +import :: swigclasswrapper +import :: swigarraywrapper type(SwigClassWrapper) :: farg1 type(SwigArrayWrapper) :: farg2 integer(C_INT), intent(in) :: farg3 @@ -2885,8 +2877,8 @@ function swigc_new_TpetraCrsGraph__SWIG_8(farg1, farg2) & bind(C, name="_wrap_new_TpetraCrsGraph__SWIG_8") & result(fresult) use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper -import :: SwigArrayWrapper +import :: swigclasswrapper +import :: swigarraywrapper type(SwigClassWrapper) :: farg1 type(SwigArrayWrapper) :: farg2 type(SwigClassWrapper) :: fresult @@ -2896,8 +2888,8 @@ function swigc_new_TpetraCrsGraph__SWIG_9(farg1, farg2, farg3, farg4, farg5) & bind(C, name="_wrap_new_TpetraCrsGraph__SWIG_9") & result(fresult) use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper -import :: SwigArrayWrapper +import :: swigclasswrapper +import :: swigarraywrapper type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 type(SwigArrayWrapper) :: farg3 @@ -2910,8 +2902,8 @@ function swigc_new_TpetraCrsGraph__SWIG_10(farg1, farg2, farg3, farg4) & bind(C, name="_wrap_new_TpetraCrsGraph__SWIG_10") & result(fresult) use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper -import :: SwigArrayWrapper +import :: swigclasswrapper +import :: swigarraywrapper type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 type(SwigArrayWrapper) :: farg3 @@ -2923,8 +2915,8 @@ function swigc_new_TpetraCrsGraph__SWIG_11(farg1, farg2, farg3) & bind(C, name="_wrap_new_TpetraCrsGraph__SWIG_11") & result(fresult) use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper -import :: SwigArrayWrapper +import :: swigclasswrapper +import :: swigarraywrapper type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 type(SwigArrayWrapper) :: farg3 @@ -2935,8 +2927,8 @@ function swigc_new_TpetraCrsGraph__SWIG_12(farg1, farg2, farg3, farg4, farg5) & bind(C, name="_wrap_new_TpetraCrsGraph__SWIG_12") & result(fresult) use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper -import :: SwigArrayWrapper +import :: swigclasswrapper +import :: swigarraywrapper type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 type(SwigArrayWrapper) :: farg3 @@ -2949,8 +2941,8 @@ function swigc_new_TpetraCrsGraph__SWIG_13(farg1, farg2, farg3, farg4) & bind(C, name="_wrap_new_TpetraCrsGraph__SWIG_13") & result(fresult) use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper -import :: SwigArrayWrapper +import :: swigclasswrapper +import :: swigarraywrapper type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 type(SwigArrayWrapper) :: farg3 @@ -2961,8 +2953,8 @@ function swigc_new_TpetraCrsGraph__SWIG_13(farg1, farg2, farg3, farg4) & subroutine swigc_TpetraCrsGraph_insertGlobalIndices__SWIG_1(farg1, farg2, farg3) & bind(C, name="_wrap_TpetraCrsGraph_insertGlobalIndices__SWIG_1") use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper -import :: SwigArrayWrapper +import :: swigclasswrapper +import :: swigarraywrapper type(SwigClassWrapper) :: farg1 integer(C_LONG_LONG), intent(in) :: farg2 type(SwigArrayWrapper) :: farg3 @@ -2971,8 +2963,8 @@ subroutine swigc_TpetraCrsGraph_insertGlobalIndices__SWIG_1(farg1, farg2, farg3) subroutine swigc_TpetraCrsGraph_insertLocalIndices(farg1, farg2, farg3) & bind(C, name="_wrap_TpetraCrsGraph_insertLocalIndices") use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper -import :: SwigArrayWrapper +import :: swigclasswrapper +import :: swigarraywrapper type(SwigClassWrapper) :: farg1 integer(C_INT), intent(in) :: farg2 type(SwigArrayWrapper) :: farg3 @@ -2981,8 +2973,8 @@ subroutine swigc_TpetraCrsGraph_insertLocalIndices(farg1, farg2, farg3) & subroutine swigc_TpetraCrsGraph_getGlobalRowCopy(farg1, farg2, farg3, farg4) & bind(C, name="_wrap_TpetraCrsGraph_getGlobalRowCopy") use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper -import :: SwigArrayWrapper +import :: swigclasswrapper +import :: swigarraywrapper type(SwigClassWrapper) :: farg1 integer(C_LONG_LONG), intent(in) :: farg2 type(SwigArrayWrapper) :: farg3 @@ -2992,8 +2984,8 @@ subroutine swigc_TpetraCrsGraph_getGlobalRowCopy(farg1, farg2, farg3, farg4) & subroutine swigc_TpetraCrsGraph_getLocalRowCopy(farg1, farg2, farg3, farg4) & bind(C, name="_wrap_TpetraCrsGraph_getLocalRowCopy") use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper -import :: SwigArrayWrapper +import :: swigclasswrapper +import :: swigarraywrapper type(SwigClassWrapper) :: farg1 integer(C_INT), intent(in) :: farg2 type(SwigArrayWrapper) :: farg3 @@ -3003,8 +2995,8 @@ subroutine swigc_TpetraCrsGraph_getLocalRowCopy(farg1, farg2, farg3, farg4) & subroutine swigc_TpetraCrsGraph_getgblRowView(farg1, farg2, farg3) & bind(C, name="_wrap_TpetraCrsGraph_getgblRowView") use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper -import :: SwigArrayWrapper +import :: swigclasswrapper +import :: swigarraywrapper type(SwigClassWrapper) :: farg1 integer(C_LONG_LONG), intent(in) :: farg2 type(SwigArrayWrapper) :: farg3 @@ -3013,8 +3005,8 @@ subroutine swigc_TpetraCrsGraph_getgblRowView(farg1, farg2, farg3) & subroutine swigc_TpetraCrsGraph_setAllIndices(farg1, farg2, farg3, farg4) & bind(C, name="_wrap_TpetraCrsGraph_setAllIndices") use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper -import :: SwigArrayWrapper +import :: swigclasswrapper +import :: swigarraywrapper type(SwigClassWrapper) :: farg1 type(SwigArrayWrapper) :: farg2 type(SwigArrayWrapper) :: farg3 @@ -3024,8 +3016,8 @@ subroutine swigc_TpetraCrsGraph_setAllIndices(farg1, farg2, farg3, farg4) & subroutine swigc_TpetraCrsGraph_getNodeRowPtrs(farg1, farg2) & bind(C, name="_wrap_TpetraCrsGraph_getNodeRowPtrs") use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper -import :: SwigArrayWrapper +import :: swigclasswrapper +import :: swigarraywrapper type(SwigClassWrapper) :: farg1 type(SwigArrayWrapper) :: farg2 end subroutine @@ -3033,8 +3025,8 @@ subroutine swigc_TpetraCrsGraph_getNodeRowPtrs(farg1, farg2) & subroutine swigc_TpetraCrsGraph_getNodePackedIndices(farg1, farg2) & bind(C, name="_wrap_TpetraCrsGraph_getNodePackedIndices") use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper -import :: SwigArrayWrapper +import :: swigclasswrapper +import :: swigarraywrapper type(SwigClassWrapper) :: farg1 type(SwigArrayWrapper) :: farg2 end subroutine @@ -3042,8 +3034,8 @@ subroutine swigc_TpetraCrsGraph_getNodePackedIndices(farg1, farg2) & subroutine swigc_TpetraCrsGraph_getLocalDiagOffsets(farg1, farg2) & bind(C, name="_wrap_TpetraCrsGraph_getLocalDiagOffsets") use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper -import :: SwigArrayWrapper +import :: swigclasswrapper +import :: swigarraywrapper type(SwigClassWrapper) :: farg1 type(SwigArrayWrapper) :: farg2 end subroutine @@ -3051,7 +3043,7 @@ subroutine swigc_TpetraCrsGraph_getLocalDiagOffsets(farg1, farg2) & subroutine swigc_TpetraCrsGraph_doImport__SWIG_0(farg1, farg2, farg3, farg4) & bind(C, name="_wrap_TpetraCrsGraph_doImport__SWIG_0") use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 type(SwigClassWrapper) :: farg3 @@ -3061,7 +3053,7 @@ subroutine swigc_TpetraCrsGraph_doImport__SWIG_0(farg1, farg2, farg3, farg4) & subroutine swigc_TpetraCrsGraph_doImport__SWIG_1(farg1, farg2, farg3, farg4) & bind(C, name="_wrap_TpetraCrsGraph_doImport__SWIG_1") use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 type(SwigClassWrapper) :: farg3 @@ -3071,7 +3063,7 @@ subroutine swigc_TpetraCrsGraph_doImport__SWIG_1(farg1, farg2, farg3, farg4) & subroutine swigc_TpetraCrsGraph_doExport__SWIG_0(farg1, farg2, farg3, farg4) & bind(C, name="_wrap_TpetraCrsGraph_doExport__SWIG_0") use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 type(SwigClassWrapper) :: farg3 @@ -3081,7 +3073,7 @@ subroutine swigc_TpetraCrsGraph_doExport__SWIG_0(farg1, farg2, farg3, farg4) & subroutine swigc_TpetraCrsGraph_doExport__SWIG_1(farg1, farg2, farg3, farg4) & bind(C, name="_wrap_TpetraCrsGraph_doExport__SWIG_1") use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 type(SwigClassWrapper) :: farg3 @@ -3099,7 +3091,7 @@ function swigc_new_TpetraCrsMatrix__SWIG_0(farg1, farg2, farg3, farg4) & bind(C, name="_wrap_new_TpetraCrsMatrix__SWIG_0") & result(fresult) use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 integer(C_SIZE_T), intent(in) :: farg2 integer(C_INT), intent(in) :: farg3 @@ -3111,7 +3103,7 @@ function swigc_new_TpetraCrsMatrix__SWIG_1(farg1, farg2, farg3) & bind(C, name="_wrap_new_TpetraCrsMatrix__SWIG_1") & result(fresult) use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 integer(C_SIZE_T), intent(in) :: farg2 integer(C_INT), intent(in) :: farg3 @@ -3122,7 +3114,7 @@ function swigc_new_TpetraCrsMatrix__SWIG_2(farg1, farg2) & bind(C, name="_wrap_new_TpetraCrsMatrix__SWIG_2") & result(fresult) use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 integer(C_SIZE_T), intent(in) :: farg2 type(SwigClassWrapper) :: fresult @@ -3132,7 +3124,7 @@ function swigc_new_TpetraCrsMatrix__SWIG_3(farg1, farg2, farg3, farg4, farg5) & bind(C, name="_wrap_new_TpetraCrsMatrix__SWIG_3") & result(fresult) use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 integer(C_SIZE_T), intent(in) :: farg3 @@ -3145,7 +3137,7 @@ function swigc_new_TpetraCrsMatrix__SWIG_4(farg1, farg2, farg3, farg4) & bind(C, name="_wrap_new_TpetraCrsMatrix__SWIG_4") & result(fresult) use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 integer(C_SIZE_T), intent(in) :: farg3 @@ -3157,7 +3149,7 @@ function swigc_new_TpetraCrsMatrix__SWIG_5(farg1, farg2, farg3) & bind(C, name="_wrap_new_TpetraCrsMatrix__SWIG_5") & result(fresult) use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 integer(C_SIZE_T), intent(in) :: farg3 @@ -3168,7 +3160,7 @@ function swigc_new_TpetraCrsMatrix__SWIG_6(farg1, farg2) & bind(C, name="_wrap_new_TpetraCrsMatrix__SWIG_6") & result(fresult) use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 type(SwigClassWrapper) :: fresult @@ -3178,7 +3170,7 @@ function swigc_new_TpetraCrsMatrix__SWIG_7(farg1) & bind(C, name="_wrap_new_TpetraCrsMatrix__SWIG_7") & result(fresult) use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: fresult end function @@ -3187,7 +3179,7 @@ function swigc_new_TpetraCrsMatrix__SWIG_8(farg1, farg2, farg3) & bind(C, name="_wrap_new_TpetraCrsMatrix__SWIG_8") & result(fresult) use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 type(SwigClassWrapper) :: farg3 @@ -3198,7 +3190,7 @@ function swigc_new_TpetraCrsMatrix__SWIG_9(farg1, farg2) & bind(C, name="_wrap_new_TpetraCrsMatrix__SWIG_9") & result(fresult) use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 type(SwigClassWrapper) :: fresult @@ -3207,14 +3199,14 @@ function swigc_new_TpetraCrsMatrix__SWIG_9(farg1, farg2) & subroutine swigc_delete_TpetraCrsMatrix(farg1) & bind(C, name="_wrap_delete_TpetraCrsMatrix") use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 end subroutine subroutine swigc_TpetraCrsMatrix_setAllToScalar(farg1, farg2) & bind(C, name="_wrap_TpetraCrsMatrix_setAllToScalar") use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 real(C_DOUBLE), intent(in) :: farg2 end subroutine @@ -3222,7 +3214,7 @@ subroutine swigc_TpetraCrsMatrix_setAllToScalar(farg1, farg2) & subroutine swigc_TpetraCrsMatrix_scale(farg1, farg2) & bind(C, name="_wrap_TpetraCrsMatrix_scale") use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 real(C_DOUBLE), intent(in) :: farg2 end subroutine @@ -3230,14 +3222,14 @@ subroutine swigc_TpetraCrsMatrix_scale(farg1, farg2) & subroutine swigc_TpetraCrsMatrix_globalAssemble(farg1) & bind(C, name="_wrap_TpetraCrsMatrix_globalAssemble") use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 end subroutine subroutine swigc_TpetraCrsMatrix_resumeFill__SWIG_0(farg1, farg2) & bind(C, name="_wrap_TpetraCrsMatrix_resumeFill__SWIG_0") use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 end subroutine @@ -3245,14 +3237,14 @@ subroutine swigc_TpetraCrsMatrix_resumeFill__SWIG_0(farg1, farg2) & subroutine swigc_TpetraCrsMatrix_resumeFill__SWIG_1(farg1) & bind(C, name="_wrap_TpetraCrsMatrix_resumeFill__SWIG_1") use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 end subroutine subroutine swigc_TpetraCrsMatrix_fillComplete__SWIG_0(farg1, farg2, farg3, farg4) & bind(C, name="_wrap_TpetraCrsMatrix_fillComplete__SWIG_0") use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 type(SwigClassWrapper) :: farg3 @@ -3262,7 +3254,7 @@ subroutine swigc_TpetraCrsMatrix_fillComplete__SWIG_0(farg1, farg2, farg3, farg4 subroutine swigc_TpetraCrsMatrix_fillComplete__SWIG_1(farg1, farg2, farg3) & bind(C, name="_wrap_TpetraCrsMatrix_fillComplete__SWIG_1") use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 type(SwigClassWrapper) :: farg3 @@ -3271,7 +3263,7 @@ subroutine swigc_TpetraCrsMatrix_fillComplete__SWIG_1(farg1, farg2, farg3) & subroutine swigc_TpetraCrsMatrix_fillComplete__SWIG_2(farg1, farg2) & bind(C, name="_wrap_TpetraCrsMatrix_fillComplete__SWIG_2") use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 end subroutine @@ -3279,14 +3271,14 @@ subroutine swigc_TpetraCrsMatrix_fillComplete__SWIG_2(farg1, farg2) & subroutine swigc_TpetraCrsMatrix_fillComplete__SWIG_3(farg1) & bind(C, name="_wrap_TpetraCrsMatrix_fillComplete__SWIG_3") use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 end subroutine subroutine swigc_TpetraCrsMatrix_expertStaticFillComplete__SWIG_0(farg1, farg2, farg3, farg4, farg5, farg6) & bind(C, name="_wrap_TpetraCrsMatrix_expertStaticFillComplete__SWIG_0") use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 type(SwigClassWrapper) :: farg3 @@ -3298,7 +3290,7 @@ subroutine swigc_TpetraCrsMatrix_expertStaticFillComplete__SWIG_0(farg1, farg2, subroutine swigc_TpetraCrsMatrix_expertStaticFillComplete__SWIG_1(farg1, farg2, farg3, farg4, farg5) & bind(C, name="_wrap_TpetraCrsMatrix_expertStaticFillComplete__SWIG_1") use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 type(SwigClassWrapper) :: farg3 @@ -3309,7 +3301,7 @@ subroutine swigc_TpetraCrsMatrix_expertStaticFillComplete__SWIG_1(farg1, farg2, subroutine swigc_TpetraCrsMatrix_expertStaticFillComplete__SWIG_2(farg1, farg2, farg3, farg4) & bind(C, name="_wrap_TpetraCrsMatrix_expertStaticFillComplete__SWIG_2") use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 type(SwigClassWrapper) :: farg3 @@ -3319,7 +3311,7 @@ subroutine swigc_TpetraCrsMatrix_expertStaticFillComplete__SWIG_2(farg1, farg2, subroutine swigc_TpetraCrsMatrix_expertStaticFillComplete__SWIG_3(farg1, farg2, farg3) & bind(C, name="_wrap_TpetraCrsMatrix_expertStaticFillComplete__SWIG_3") use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 type(SwigClassWrapper) :: farg3 @@ -3328,7 +3320,7 @@ subroutine swigc_TpetraCrsMatrix_expertStaticFillComplete__SWIG_3(farg1, farg2, subroutine swigc_TpetraCrsMatrix_replaceColMap(farg1, farg2) & bind(C, name="_wrap_TpetraCrsMatrix_replaceColMap") use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 end subroutine @@ -3336,7 +3328,7 @@ subroutine swigc_TpetraCrsMatrix_replaceColMap(farg1, farg2) & subroutine swigc_TpetraCrsMatrix_reindexColumns__SWIG_0(farg1, farg2, farg3, farg4, farg5) & bind(C, name="_wrap_TpetraCrsMatrix_reindexColumns__SWIG_0") use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 type(SwigClassWrapper) :: farg3 @@ -3347,7 +3339,7 @@ subroutine swigc_TpetraCrsMatrix_reindexColumns__SWIG_0(farg1, farg2, farg3, far subroutine swigc_TpetraCrsMatrix_reindexColumns__SWIG_1(farg1, farg2, farg3, farg4) & bind(C, name="_wrap_TpetraCrsMatrix_reindexColumns__SWIG_1") use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 type(SwigClassWrapper) :: farg3 @@ -3357,7 +3349,7 @@ subroutine swigc_TpetraCrsMatrix_reindexColumns__SWIG_1(farg1, farg2, farg3, far subroutine swigc_TpetraCrsMatrix_reindexColumns__SWIG_2(farg1, farg2, farg3) & bind(C, name="_wrap_TpetraCrsMatrix_reindexColumns__SWIG_2") use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 type(SwigClassWrapper) :: farg3 @@ -3366,7 +3358,7 @@ subroutine swigc_TpetraCrsMatrix_reindexColumns__SWIG_2(farg1, farg2, farg3) & subroutine swigc_TpetraCrsMatrix_replaceDomainMapAndImporter(farg1, farg2, farg3) & bind(C, name="_wrap_TpetraCrsMatrix_replaceDomainMapAndImporter") use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 type(SwigClassWrapper) :: farg3 @@ -3375,7 +3367,7 @@ subroutine swigc_TpetraCrsMatrix_replaceDomainMapAndImporter(farg1, farg2, farg3 subroutine swigc_TpetraCrsMatrix_removeEmptyProcessesInPlace(farg1, farg2) & bind(C, name="_wrap_TpetraCrsMatrix_removeEmptyProcessesInPlace") use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 end subroutine @@ -3384,7 +3376,7 @@ function swigc_TpetraCrsMatrix_getComm(farg1) & bind(C, name="_wrap_TpetraCrsMatrix_getComm") & result(fresult) use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: fresult end function @@ -3393,7 +3385,7 @@ function swigc_TpetraCrsMatrix_getRowMap(farg1) & bind(C, name="_wrap_TpetraCrsMatrix_getRowMap") & result(fresult) use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: fresult end function @@ -3402,7 +3394,7 @@ function swigc_TpetraCrsMatrix_getColMap(farg1) & bind(C, name="_wrap_TpetraCrsMatrix_getColMap") & result(fresult) use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: fresult end function @@ -3411,7 +3403,7 @@ function swigc_TpetraCrsMatrix_getCrsGraph(farg1) & bind(C, name="_wrap_TpetraCrsMatrix_getCrsGraph") & result(fresult) use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: fresult end function @@ -3420,7 +3412,7 @@ function swigc_TpetraCrsMatrix_getGlobalNumRows(farg1) & bind(C, name="_wrap_TpetraCrsMatrix_getGlobalNumRows") & result(fresult) use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 integer(C_LONG) :: fresult end function @@ -3429,7 +3421,7 @@ function swigc_TpetraCrsMatrix_getGlobalNumCols(farg1) & bind(C, name="_wrap_TpetraCrsMatrix_getGlobalNumCols") & result(fresult) use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 integer(C_LONG) :: fresult end function @@ -3438,7 +3430,7 @@ function swigc_TpetraCrsMatrix_getNodeNumRows(farg1) & bind(C, name="_wrap_TpetraCrsMatrix_getNodeNumRows") & result(fresult) use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 integer(C_SIZE_T) :: fresult end function @@ -3447,7 +3439,7 @@ function swigc_TpetraCrsMatrix_getNodeNumCols(farg1) & bind(C, name="_wrap_TpetraCrsMatrix_getNodeNumCols") & result(fresult) use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 integer(C_SIZE_T) :: fresult end function @@ -3456,7 +3448,7 @@ function swigc_TpetraCrsMatrix_getGlobalNumEntries(farg1) & bind(C, name="_wrap_TpetraCrsMatrix_getGlobalNumEntries") & result(fresult) use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 integer(C_LONG) :: fresult end function @@ -3465,7 +3457,7 @@ function swigc_TpetraCrsMatrix_getNodeNumEntries(farg1) & bind(C, name="_wrap_TpetraCrsMatrix_getNodeNumEntries") & result(fresult) use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 integer(C_SIZE_T) :: fresult end function @@ -3474,7 +3466,7 @@ function swigc_TpetraCrsMatrix_getNumEntriesInGlobalRow(farg1, farg2) & bind(C, name="_wrap_TpetraCrsMatrix_getNumEntriesInGlobalRow") & result(fresult) use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 integer(C_LONG_LONG), intent(in) :: farg2 integer(C_SIZE_T) :: fresult @@ -3484,7 +3476,7 @@ function swigc_TpetraCrsMatrix_getNumEntriesInLocalRow(farg1, farg2) & bind(C, name="_wrap_TpetraCrsMatrix_getNumEntriesInLocalRow") & result(fresult) use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 integer(C_INT), intent(in) :: farg2 integer(C_SIZE_T) :: fresult @@ -3494,7 +3486,7 @@ function swigc_TpetraCrsMatrix_getGlobalNumDiagsImpl(farg1) & bind(C, name="_wrap_TpetraCrsMatrix_getGlobalNumDiagsImpl") & result(fresult) use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 integer(C_LONG) :: fresult end function @@ -3503,7 +3495,7 @@ function swigc_TpetraCrsMatrix_getGlobalNumDiags(farg1) & bind(C, name="_wrap_TpetraCrsMatrix_getGlobalNumDiags") & result(fresult) use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 integer(C_LONG) :: fresult end function @@ -3512,7 +3504,7 @@ function swigc_TpetraCrsMatrix_getNodeNumDiagsImpl(farg1) & bind(C, name="_wrap_TpetraCrsMatrix_getNodeNumDiagsImpl") & result(fresult) use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 integer(C_SIZE_T) :: fresult end function @@ -3521,7 +3513,7 @@ function swigc_TpetraCrsMatrix_getNodeNumDiags(farg1) & bind(C, name="_wrap_TpetraCrsMatrix_getNodeNumDiags") & result(fresult) use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 integer(C_SIZE_T) :: fresult end function @@ -3530,7 +3522,7 @@ function swigc_TpetraCrsMatrix_getGlobalMaxNumRowEntries(farg1) & bind(C, name="_wrap_TpetraCrsMatrix_getGlobalMaxNumRowEntries") & result(fresult) use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 integer(C_SIZE_T) :: fresult end function @@ -3539,7 +3531,7 @@ function swigc_TpetraCrsMatrix_getNodeMaxNumRowEntries(farg1) & bind(C, name="_wrap_TpetraCrsMatrix_getNodeMaxNumRowEntries") & result(fresult) use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 integer(C_SIZE_T) :: fresult end function @@ -3548,7 +3540,7 @@ function swigc_TpetraCrsMatrix_hasColMap(farg1) & bind(C, name="_wrap_TpetraCrsMatrix_hasColMap") & result(fresult) use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 logical(C_BOOL) :: fresult end function @@ -3557,7 +3549,7 @@ function swigc_TpetraCrsMatrix_isLowerTriangularImpl(farg1) & bind(C, name="_wrap_TpetraCrsMatrix_isLowerTriangularImpl") & result(fresult) use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 logical(C_BOOL) :: fresult end function @@ -3566,7 +3558,7 @@ function swigc_TpetraCrsMatrix_isLowerTriangular(farg1) & bind(C, name="_wrap_TpetraCrsMatrix_isLowerTriangular") & result(fresult) use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 logical(C_BOOL) :: fresult end function @@ -3575,7 +3567,7 @@ function swigc_TpetraCrsMatrix_isUpperTriangularImpl(farg1) & bind(C, name="_wrap_TpetraCrsMatrix_isUpperTriangularImpl") & result(fresult) use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 logical(C_BOOL) :: fresult end function @@ -3584,7 +3576,7 @@ function swigc_TpetraCrsMatrix_isUpperTriangular(farg1) & bind(C, name="_wrap_TpetraCrsMatrix_isUpperTriangular") & result(fresult) use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 logical(C_BOOL) :: fresult end function @@ -3593,7 +3585,7 @@ function swigc_TpetraCrsMatrix_isLocallyIndexed(farg1) & bind(C, name="_wrap_TpetraCrsMatrix_isLocallyIndexed") & result(fresult) use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 logical(C_BOOL) :: fresult end function @@ -3602,7 +3594,7 @@ function swigc_TpetraCrsMatrix_isGloballyIndexed(farg1) & bind(C, name="_wrap_TpetraCrsMatrix_isGloballyIndexed") & result(fresult) use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 logical(C_BOOL) :: fresult end function @@ -3611,7 +3603,7 @@ function swigc_TpetraCrsMatrix_isFillComplete(farg1) & bind(C, name="_wrap_TpetraCrsMatrix_isFillComplete") & result(fresult) use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 logical(C_BOOL) :: fresult end function @@ -3620,7 +3612,7 @@ function swigc_TpetraCrsMatrix_isFillActive(farg1) & bind(C, name="_wrap_TpetraCrsMatrix_isFillActive") & result(fresult) use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 logical(C_BOOL) :: fresult end function @@ -3629,7 +3621,7 @@ function swigc_TpetraCrsMatrix_isStorageOptimized(farg1) & bind(C, name="_wrap_TpetraCrsMatrix_isStorageOptimized") & result(fresult) use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 logical(C_BOOL) :: fresult end function @@ -3638,7 +3630,7 @@ function swigc_TpetraCrsMatrix_getProfileType(farg1) & bind(C, name="_wrap_TpetraCrsMatrix_getProfileType") & result(fresult) use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 integer(C_INT) :: fresult end function @@ -3647,7 +3639,7 @@ function swigc_TpetraCrsMatrix_isStaticGraph(farg1) & bind(C, name="_wrap_TpetraCrsMatrix_isStaticGraph") & result(fresult) use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 logical(C_BOOL) :: fresult end function @@ -3656,7 +3648,7 @@ function swigc_TpetraCrsMatrix_getFrobeniusNorm(farg1) & bind(C, name="_wrap_TpetraCrsMatrix_getFrobeniusNorm") & result(fresult) use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 real(C_DOUBLE) :: fresult end function @@ -3665,7 +3657,7 @@ function swigc_TpetraCrsMatrix_supportsRowViews(farg1) & bind(C, name="_wrap_TpetraCrsMatrix_supportsRowViews") & result(fresult) use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 logical(C_BOOL) :: fresult end function @@ -3673,7 +3665,7 @@ function swigc_TpetraCrsMatrix_supportsRowViews(farg1) & subroutine swigc_TpetraCrsMatrix_apply__SWIG_0(farg1, farg2, farg3, farg4, farg5, farg6) & bind(C, name="_wrap_TpetraCrsMatrix_apply__SWIG_0") use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 type(SwigClassWrapper) :: farg3 @@ -3685,7 +3677,7 @@ subroutine swigc_TpetraCrsMatrix_apply__SWIG_0(farg1, farg2, farg3, farg4, farg5 subroutine swigc_TpetraCrsMatrix_apply__SWIG_1(farg1, farg2, farg3, farg4, farg5) & bind(C, name="_wrap_TpetraCrsMatrix_apply__SWIG_1") use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 type(SwigClassWrapper) :: farg3 @@ -3696,7 +3688,7 @@ subroutine swigc_TpetraCrsMatrix_apply__SWIG_1(farg1, farg2, farg3, farg4, farg5 subroutine swigc_TpetraCrsMatrix_apply__SWIG_2(farg1, farg2, farg3, farg4) & bind(C, name="_wrap_TpetraCrsMatrix_apply__SWIG_2") use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 type(SwigClassWrapper) :: farg3 @@ -3706,7 +3698,7 @@ subroutine swigc_TpetraCrsMatrix_apply__SWIG_2(farg1, farg2, farg3, farg4) & subroutine swigc_TpetraCrsMatrix_apply__SWIG_3(farg1, farg2, farg3) & bind(C, name="_wrap_TpetraCrsMatrix_apply__SWIG_3") use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 type(SwigClassWrapper) :: farg3 @@ -3716,7 +3708,7 @@ function swigc_TpetraCrsMatrix_hasTransposeApply(farg1) & bind(C, name="_wrap_TpetraCrsMatrix_hasTransposeApply") & result(fresult) use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 logical(C_BOOL) :: fresult end function @@ -3725,7 +3717,7 @@ function swigc_TpetraCrsMatrix_getDomainMap(farg1) & bind(C, name="_wrap_TpetraCrsMatrix_getDomainMap") & result(fresult) use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: fresult end function @@ -3734,7 +3726,7 @@ function swigc_TpetraCrsMatrix_getRangeMap(farg1) & bind(C, name="_wrap_TpetraCrsMatrix_getRangeMap") & result(fresult) use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: fresult end function @@ -3742,7 +3734,7 @@ function swigc_TpetraCrsMatrix_getRangeMap(farg1) & subroutine swigc_TpetraCrsMatrix_gaussSeidel(farg1, farg2, farg3, farg4, farg5, farg6, farg7) & bind(C, name="_wrap_TpetraCrsMatrix_gaussSeidel") use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 type(SwigClassWrapper) :: farg3 @@ -3755,7 +3747,7 @@ subroutine swigc_TpetraCrsMatrix_gaussSeidel(farg1, farg2, farg3, farg4, farg5, subroutine swigc_TpetraCrsMatrix_gaussSeidelCopy(farg1, farg2, farg3, farg4, farg5, farg6, farg7, farg8) & bind(C, name="_wrap_TpetraCrsMatrix_gaussSeidelCopy") use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 type(SwigClassWrapper) :: farg3 @@ -3770,8 +3762,8 @@ function swigc_TpetraCrsMatrix_description(farg1) & bind(C, name="_wrap_TpetraCrsMatrix_description") & result(fresult) use, intrinsic :: ISO_C_BINDING -import :: SwigArrayWrapper -import :: SwigClassWrapper +import :: swigarraywrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 type(SwigArrayWrapper) :: fresult end function @@ -3779,7 +3771,7 @@ function swigc_TpetraCrsMatrix_description(farg1) & subroutine swigc_TpetraCrsMatrix_importAndFillComplete__SWIG_0(farg1, farg2, farg3, farg4, farg5, farg6) & bind(C, name="_wrap_TpetraCrsMatrix_importAndFillComplete__SWIG_0") use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 type(SwigClassWrapper) :: farg3 @@ -3791,7 +3783,7 @@ subroutine swigc_TpetraCrsMatrix_importAndFillComplete__SWIG_0(farg1, farg2, far subroutine swigc_TpetraCrsMatrix_importAndFillComplete__SWIG_1(farg1, farg2, farg3, farg4, farg5) & bind(C, name="_wrap_TpetraCrsMatrix_importAndFillComplete__SWIG_1") use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 type(SwigClassWrapper) :: farg3 @@ -3802,7 +3794,7 @@ subroutine swigc_TpetraCrsMatrix_importAndFillComplete__SWIG_1(farg1, farg2, far subroutine swigc_TpetraCrsMatrix_importAndFillComplete__SWIG_2(farg1, farg2, farg3, farg4, farg5, farg6, farg7) & bind(C, name="_wrap_TpetraCrsMatrix_importAndFillComplete__SWIG_2") use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 type(SwigClassWrapper) :: farg3 @@ -3815,7 +3807,7 @@ subroutine swigc_TpetraCrsMatrix_importAndFillComplete__SWIG_2(farg1, farg2, far subroutine swigc_TpetraCrsMatrix_exportAndFillComplete__SWIG_0(farg1, farg2, farg3, farg4, farg5, farg6) & bind(C, name="_wrap_TpetraCrsMatrix_exportAndFillComplete__SWIG_0") use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 type(SwigClassWrapper) :: farg3 @@ -3827,7 +3819,7 @@ subroutine swigc_TpetraCrsMatrix_exportAndFillComplete__SWIG_0(farg1, farg2, far subroutine swigc_TpetraCrsMatrix_exportAndFillComplete__SWIG_1(farg1, farg2, farg3, farg4, farg5) & bind(C, name="_wrap_TpetraCrsMatrix_exportAndFillComplete__SWIG_1") use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 type(SwigClassWrapper) :: farg3 @@ -3838,7 +3830,7 @@ subroutine swigc_TpetraCrsMatrix_exportAndFillComplete__SWIG_1(farg1, farg2, far subroutine swigc_TpetraCrsMatrix_exportAndFillComplete__SWIG_2(farg1, farg2, farg3, farg4) & bind(C, name="_wrap_TpetraCrsMatrix_exportAndFillComplete__SWIG_2") use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 type(SwigClassWrapper) :: farg3 @@ -3848,7 +3840,7 @@ subroutine swigc_TpetraCrsMatrix_exportAndFillComplete__SWIG_2(farg1, farg2, far subroutine swigc_TpetraCrsMatrix_exportAndFillComplete__SWIG_3(farg1, farg2, farg3) & bind(C, name="_wrap_TpetraCrsMatrix_exportAndFillComplete__SWIG_3") use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 type(SwigClassWrapper) :: farg3 @@ -3857,7 +3849,7 @@ subroutine swigc_TpetraCrsMatrix_exportAndFillComplete__SWIG_3(farg1, farg2, far subroutine swigc_TpetraCrsMatrix_exportAndFillComplete__SWIG_4(farg1, farg2, farg3, farg4, farg5, farg6, farg7) & bind(C, name="_wrap_TpetraCrsMatrix_exportAndFillComplete__SWIG_4") use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 type(SwigClassWrapper) :: farg3 @@ -3870,7 +3862,7 @@ subroutine swigc_TpetraCrsMatrix_exportAndFillComplete__SWIG_4(farg1, farg2, far subroutine swigc_TpetraCrsMatrix_computeGlobalConstants(farg1) & bind(C, name="_wrap_TpetraCrsMatrix_computeGlobalConstants") use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 end subroutine @@ -3878,7 +3870,7 @@ function swigc_TpetraCrsMatrix_haveGlobalConstants(farg1) & bind(C, name="_wrap_TpetraCrsMatrix_haveGlobalConstants") & result(fresult) use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 logical(C_BOOL) :: fresult end function @@ -3887,8 +3879,8 @@ function swigc_new_TpetraCrsMatrix__SWIG_10(farg1, farg2, farg3, farg4) & bind(C, name="_wrap_new_TpetraCrsMatrix__SWIG_10") & result(fresult) use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper -import :: SwigArrayWrapper +import :: swigclasswrapper +import :: swigarraywrapper type(SwigClassWrapper) :: farg1 type(SwigArrayWrapper) :: farg2 integer(C_INT), intent(in) :: farg3 @@ -3900,8 +3892,8 @@ function swigc_new_TpetraCrsMatrix__SWIG_11(farg1, farg2, farg3) & bind(C, name="_wrap_new_TpetraCrsMatrix__SWIG_11") & result(fresult) use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper -import :: SwigArrayWrapper +import :: swigclasswrapper +import :: swigarraywrapper type(SwigClassWrapper) :: farg1 type(SwigArrayWrapper) :: farg2 integer(C_INT), intent(in) :: farg3 @@ -3912,8 +3904,8 @@ function swigc_new_TpetraCrsMatrix__SWIG_12(farg1, farg2) & bind(C, name="_wrap_new_TpetraCrsMatrix__SWIG_12") & result(fresult) use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper -import :: SwigArrayWrapper +import :: swigclasswrapper +import :: swigarraywrapper type(SwigClassWrapper) :: farg1 type(SwigArrayWrapper) :: farg2 type(SwigClassWrapper) :: fresult @@ -3923,8 +3915,8 @@ function swigc_new_TpetraCrsMatrix__SWIG_13(farg1, farg2, farg3, farg4, farg5) & bind(C, name="_wrap_new_TpetraCrsMatrix__SWIG_13") & result(fresult) use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper -import :: SwigArrayWrapper +import :: swigclasswrapper +import :: swigarraywrapper type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 type(SwigArrayWrapper) :: farg3 @@ -3937,8 +3929,8 @@ function swigc_new_TpetraCrsMatrix__SWIG_14(farg1, farg2, farg3, farg4) & bind(C, name="_wrap_new_TpetraCrsMatrix__SWIG_14") & result(fresult) use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper -import :: SwigArrayWrapper +import :: swigclasswrapper +import :: swigarraywrapper type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 type(SwigArrayWrapper) :: farg3 @@ -3950,8 +3942,8 @@ function swigc_new_TpetraCrsMatrix__SWIG_15(farg1, farg2, farg3) & bind(C, name="_wrap_new_TpetraCrsMatrix__SWIG_15") & result(fresult) use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper -import :: SwigArrayWrapper +import :: swigclasswrapper +import :: swigarraywrapper type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 type(SwigArrayWrapper) :: farg3 @@ -3962,8 +3954,8 @@ function swigc_new_TpetraCrsMatrix__SWIG_16(farg1, farg2, farg3, farg4, farg5, f bind(C, name="_wrap_new_TpetraCrsMatrix__SWIG_16") & result(fresult) use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper -import :: SwigArrayWrapper +import :: swigclasswrapper +import :: swigarraywrapper type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 type(SwigArrayWrapper) :: farg3 @@ -3977,8 +3969,8 @@ function swigc_new_TpetraCrsMatrix__SWIG_17(farg1, farg2, farg3, farg4, farg5) & bind(C, name="_wrap_new_TpetraCrsMatrix__SWIG_17") & result(fresult) use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper -import :: SwigArrayWrapper +import :: swigclasswrapper +import :: swigarraywrapper type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 type(SwigArrayWrapper) :: farg3 @@ -3990,8 +3982,8 @@ function swigc_new_TpetraCrsMatrix__SWIG_17(farg1, farg2, farg3, farg4, farg5) & subroutine swigc_TpetraCrsMatrix_insertGlobalValues(farg1, farg2, farg3, farg4) & bind(C, name="_wrap_TpetraCrsMatrix_insertGlobalValues") use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper -import :: SwigArrayWrapper +import :: swigclasswrapper +import :: swigarraywrapper type(SwigClassWrapper) :: farg1 integer(C_LONG_LONG), intent(in) :: farg2 type(SwigArrayWrapper) :: farg3 @@ -4001,8 +3993,8 @@ subroutine swigc_TpetraCrsMatrix_insertGlobalValues(farg1, farg2, farg3, farg4) subroutine swigc_TpetraCrsMatrix_insertLocalValues(farg1, farg2, farg3, farg4) & bind(C, name="_wrap_TpetraCrsMatrix_insertLocalValues") use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper -import :: SwigArrayWrapper +import :: swigclasswrapper +import :: swigarraywrapper type(SwigClassWrapper) :: farg1 integer(C_INT), intent(in) :: farg2 type(SwigArrayWrapper) :: farg3 @@ -4013,8 +4005,8 @@ function swigc_TpetraCrsMatrix_replaceGlobalValues(farg1, farg2, farg3, farg4) & bind(C, name="_wrap_TpetraCrsMatrix_replaceGlobalValues") & result(fresult) use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper -import :: SwigArrayWrapper +import :: swigclasswrapper +import :: swigarraywrapper type(SwigClassWrapper) :: farg1 integer(C_LONG_LONG), intent(in) :: farg2 type(SwigArrayWrapper) :: farg3 @@ -4026,8 +4018,8 @@ function swigc_TpetraCrsMatrix_sumIntoGlobalValues(farg1, farg2, farg3, farg4) & bind(C, name="_wrap_TpetraCrsMatrix_sumIntoGlobalValues") & result(fresult) use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper -import :: SwigArrayWrapper +import :: swigclasswrapper +import :: swigarraywrapper type(SwigClassWrapper) :: farg1 integer(C_LONG_LONG), intent(in) :: farg2 type(SwigArrayWrapper) :: farg3 @@ -4038,8 +4030,8 @@ function swigc_TpetraCrsMatrix_sumIntoGlobalValues(farg1, farg2, farg3, farg4) & subroutine swigc_TpetraCrsMatrix_setAllValues(farg1, farg2, farg3, farg4) & bind(C, name="_wrap_TpetraCrsMatrix_setAllValues") use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper -import :: SwigArrayWrapper +import :: swigclasswrapper +import :: swigarraywrapper type(SwigClassWrapper) :: farg1 type(SwigArrayWrapper) :: farg2 type(SwigArrayWrapper) :: farg3 @@ -4049,8 +4041,8 @@ subroutine swigc_TpetraCrsMatrix_setAllValues(farg1, farg2, farg3, farg4) & subroutine swigc_TpetraCrsMatrix_getAllValues(farg1, farg2, farg3, farg4) & bind(C, name="_wrap_TpetraCrsMatrix_getAllValues") use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper -import :: SwigArrayWrapper +import :: swigclasswrapper +import :: swigarraywrapper type(SwigClassWrapper) :: farg1 type(SwigArrayWrapper) :: farg2 type(SwigArrayWrapper) :: farg3 @@ -4060,8 +4052,8 @@ subroutine swigc_TpetraCrsMatrix_getAllValues(farg1, farg2, farg3, farg4) & subroutine swigc_TpetraCrsMatrix_getGlobalRowCopy(farg1, farg2, farg3, farg4, farg5) & bind(C, name="_wrap_TpetraCrsMatrix_getGlobalRowCopy") use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper -import :: SwigArrayWrapper +import :: swigclasswrapper +import :: swigarraywrapper type(SwigClassWrapper) :: farg1 integer(C_LONG_LONG), intent(in) :: farg2 type(SwigArrayWrapper) :: farg3 @@ -4072,8 +4064,8 @@ subroutine swigc_TpetraCrsMatrix_getGlobalRowCopy(farg1, farg2, farg3, farg4, fa subroutine swigc_TpetraCrsMatrix_getLocalRowCopy(farg1, farg2, farg3, farg4, farg5) & bind(C, name="_wrap_TpetraCrsMatrix_getLocalRowCopy") use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper -import :: SwigArrayWrapper +import :: swigclasswrapper +import :: swigarraywrapper type(SwigClassWrapper) :: farg1 integer(C_INT), intent(in) :: farg2 type(SwigArrayWrapper) :: farg3 @@ -4084,8 +4076,8 @@ subroutine swigc_TpetraCrsMatrix_getLocalRowCopy(farg1, farg2, farg3, farg4, far subroutine swigc_TpetraCrsMatrix_getGlobalRowView(farg1, farg2, farg3, farg4) & bind(C, name="_wrap_TpetraCrsMatrix_getGlobalRowView") use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper -import :: SwigArrayWrapper +import :: swigclasswrapper +import :: swigarraywrapper type(SwigClassWrapper) :: farg1 integer(C_LONG_LONG), intent(in) :: farg2 type(SwigArrayWrapper) :: farg3 @@ -4095,8 +4087,8 @@ subroutine swigc_TpetraCrsMatrix_getGlobalRowView(farg1, farg2, farg3, farg4) & subroutine swigc_TpetraCrsMatrix_getLocalDiagOffsets(farg1, farg2) & bind(C, name="_wrap_TpetraCrsMatrix_getLocalDiagOffsets") use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper -import :: SwigArrayWrapper +import :: swigclasswrapper +import :: swigarraywrapper type(SwigClassWrapper) :: farg1 type(SwigArrayWrapper) :: farg2 end subroutine @@ -4104,7 +4096,7 @@ subroutine swigc_TpetraCrsMatrix_getLocalDiagOffsets(farg1, farg2) & subroutine swigc_TpetraCrsMatrix_doImport__SWIG_0(farg1, farg2, farg3, farg4) & bind(C, name="_wrap_TpetraCrsMatrix_doImport__SWIG_0") use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 type(SwigClassWrapper) :: farg3 @@ -4114,7 +4106,7 @@ subroutine swigc_TpetraCrsMatrix_doImport__SWIG_0(farg1, farg2, farg3, farg4) & subroutine swigc_TpetraCrsMatrix_doImport__SWIG_1(farg1, farg2, farg3, farg4) & bind(C, name="_wrap_TpetraCrsMatrix_doImport__SWIG_1") use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 type(SwigClassWrapper) :: farg3 @@ -4124,7 +4116,7 @@ subroutine swigc_TpetraCrsMatrix_doImport__SWIG_1(farg1, farg2, farg3, farg4) & subroutine swigc_TpetraCrsMatrix_doExport__SWIG_0(farg1, farg2, farg3, farg4) & bind(C, name="_wrap_TpetraCrsMatrix_doExport__SWIG_0") use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 type(SwigClassWrapper) :: farg3 @@ -4134,7 +4126,7 @@ subroutine swigc_TpetraCrsMatrix_doExport__SWIG_0(farg1, farg2, farg3, farg4) & subroutine swigc_TpetraCrsMatrix_doExport__SWIG_1(farg1, farg2, farg3, farg4) & bind(C, name="_wrap_TpetraCrsMatrix_doExport__SWIG_1") use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 type(SwigClassWrapper) :: farg3 @@ -4152,7 +4144,7 @@ function swigc_operator_to_matrix(farg1) & bind(C, name="_wrap_operator_to_matrix") & result(fresult) use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: fresult end function @@ -4161,7 +4153,7 @@ function swigc_matrix_to_operator(farg1) & bind(C, name="_wrap_matrix_to_operator") & result(fresult) use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: fresult end function @@ -4170,8 +4162,8 @@ function swigc_TpetraReader_readSparseGraphFile__SWIG_0(farg1, farg2, farg3, far bind(C, name="_wrap_TpetraReader_readSparseGraphFile__SWIG_0") & result(fresult) use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper -import :: SwigArrayWrapper +import :: swigclasswrapper +import :: swigarraywrapper type(SwigArrayWrapper) :: farg1 type(SwigClassWrapper) :: farg2 logical(C_BOOL), intent(in) :: farg3 @@ -4184,8 +4176,8 @@ function swigc_TpetraReader_readSparseGraphFile__SWIG_1(farg1, farg2, farg3, far bind(C, name="_wrap_TpetraReader_readSparseGraphFile__SWIG_1") & result(fresult) use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper -import :: SwigArrayWrapper +import :: swigclasswrapper +import :: swigarraywrapper type(SwigArrayWrapper) :: farg1 type(SwigClassWrapper) :: farg2 logical(C_BOOL), intent(in) :: farg3 @@ -4197,8 +4189,8 @@ function swigc_TpetraReader_readSparseGraphFile__SWIG_2(farg1, farg2, farg3) & bind(C, name="_wrap_TpetraReader_readSparseGraphFile__SWIG_2") & result(fresult) use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper -import :: SwigArrayWrapper +import :: swigclasswrapper +import :: swigarraywrapper type(SwigArrayWrapper) :: farg1 type(SwigClassWrapper) :: farg2 logical(C_BOOL), intent(in) :: farg3 @@ -4209,8 +4201,8 @@ function swigc_TpetraReader_readSparseGraphFile__SWIG_3(farg1, farg2) & bind(C, name="_wrap_TpetraReader_readSparseGraphFile__SWIG_3") & result(fresult) use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper -import :: SwigArrayWrapper +import :: swigclasswrapper +import :: swigarraywrapper type(SwigArrayWrapper) :: farg1 type(SwigClassWrapper) :: farg2 type(SwigClassWrapper) :: fresult @@ -4220,8 +4212,8 @@ function swigc_TpetraReader_readSparseGraphFile__SWIG_4(farg1, farg2, farg3, far bind(C, name="_wrap_TpetraReader_readSparseGraphFile__SWIG_4") & result(fresult) use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper -import :: SwigArrayWrapper +import :: swigclasswrapper +import :: swigarraywrapper type(SwigArrayWrapper) :: farg1 type(SwigClassWrapper) :: farg2 type(SwigClassWrapper) :: farg3 @@ -4235,8 +4227,8 @@ function swigc_TpetraReader_readSparseGraphFile__SWIG_5(farg1, farg2, farg3, far bind(C, name="_wrap_TpetraReader_readSparseGraphFile__SWIG_5") & result(fresult) use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper -import :: SwigArrayWrapper +import :: swigclasswrapper +import :: swigarraywrapper type(SwigArrayWrapper) :: farg1 type(SwigClassWrapper) :: farg2 type(SwigClassWrapper) :: farg3 @@ -4249,8 +4241,8 @@ function swigc_TpetraReader_readSparseGraphFile__SWIG_6(farg1, farg2, farg3, far bind(C, name="_wrap_TpetraReader_readSparseGraphFile__SWIG_6") & result(fresult) use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper -import :: SwigArrayWrapper +import :: swigclasswrapper +import :: swigarraywrapper type(SwigArrayWrapper) :: farg1 type(SwigClassWrapper) :: farg2 type(SwigClassWrapper) :: farg3 @@ -4262,8 +4254,8 @@ function swigc_TpetraReader_readSparseGraphFile__SWIG_7(farg1, farg2, farg3, far bind(C, name="_wrap_TpetraReader_readSparseGraphFile__SWIG_7") & result(fresult) use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper -import :: SwigArrayWrapper +import :: swigclasswrapper +import :: swigarraywrapper type(SwigArrayWrapper) :: farg1 type(SwigClassWrapper) :: farg2 type(SwigClassWrapper) :: farg3 @@ -4279,8 +4271,8 @@ function swigc_TpetraReader_readSparseGraphFile__SWIG_8(farg1, farg2, farg3, far bind(C, name="_wrap_TpetraReader_readSparseGraphFile__SWIG_8") & result(fresult) use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper -import :: SwigArrayWrapper +import :: swigclasswrapper +import :: swigarraywrapper type(SwigArrayWrapper) :: farg1 type(SwigClassWrapper) :: farg2 type(SwigClassWrapper) :: farg3 @@ -4295,8 +4287,8 @@ function swigc_TpetraReader_readSparseGraphFile__SWIG_9(farg1, farg2, farg3, far bind(C, name="_wrap_TpetraReader_readSparseGraphFile__SWIG_9") & result(fresult) use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper -import :: SwigArrayWrapper +import :: swigclasswrapper +import :: swigarraywrapper type(SwigArrayWrapper) :: farg1 type(SwigClassWrapper) :: farg2 type(SwigClassWrapper) :: farg3 @@ -4310,8 +4302,8 @@ function swigc_TpetraReader_readSparseGraphFile__SWIG_10(farg1, farg2, farg3, fa bind(C, name="_wrap_TpetraReader_readSparseGraphFile__SWIG_10") & result(fresult) use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper -import :: SwigArrayWrapper +import :: swigclasswrapper +import :: swigarraywrapper type(SwigArrayWrapper) :: farg1 type(SwigClassWrapper) :: farg2 type(SwigClassWrapper) :: farg3 @@ -4324,8 +4316,8 @@ function swigc_TpetraReader_readSparseFile__SWIG_0(farg1, farg2, farg3, farg4, f bind(C, name="_wrap_TpetraReader_readSparseFile__SWIG_0") & result(fresult) use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper -import :: SwigArrayWrapper +import :: swigclasswrapper +import :: swigarraywrapper type(SwigArrayWrapper) :: farg1 type(SwigClassWrapper) :: farg2 logical(C_BOOL), intent(in) :: farg3 @@ -4338,8 +4330,8 @@ function swigc_TpetraReader_readSparseFile__SWIG_1(farg1, farg2, farg3, farg4) & bind(C, name="_wrap_TpetraReader_readSparseFile__SWIG_1") & result(fresult) use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper -import :: SwigArrayWrapper +import :: swigclasswrapper +import :: swigarraywrapper type(SwigArrayWrapper) :: farg1 type(SwigClassWrapper) :: farg2 logical(C_BOOL), intent(in) :: farg3 @@ -4351,8 +4343,8 @@ function swigc_TpetraReader_readSparseFile__SWIG_2(farg1, farg2, farg3) & bind(C, name="_wrap_TpetraReader_readSparseFile__SWIG_2") & result(fresult) use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper -import :: SwigArrayWrapper +import :: swigclasswrapper +import :: swigarraywrapper type(SwigArrayWrapper) :: farg1 type(SwigClassWrapper) :: farg2 logical(C_BOOL), intent(in) :: farg3 @@ -4363,8 +4355,8 @@ function swigc_TpetraReader_readSparseFile__SWIG_3(farg1, farg2) & bind(C, name="_wrap_TpetraReader_readSparseFile__SWIG_3") & result(fresult) use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper -import :: SwigArrayWrapper +import :: swigclasswrapper +import :: swigarraywrapper type(SwigArrayWrapper) :: farg1 type(SwigClassWrapper) :: farg2 type(SwigClassWrapper) :: fresult @@ -4374,8 +4366,8 @@ function swigc_TpetraReader_readSparseFile__SWIG_4(farg1, farg2, farg3, farg4, f bind(C, name="_wrap_TpetraReader_readSparseFile__SWIG_4") & result(fresult) use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper -import :: SwigArrayWrapper +import :: swigclasswrapper +import :: swigarraywrapper type(SwigArrayWrapper) :: farg1 type(SwigClassWrapper) :: farg2 type(SwigClassWrapper) :: farg3 @@ -4389,8 +4381,8 @@ function swigc_TpetraReader_readSparseFile__SWIG_5(farg1, farg2, farg3, farg4, f bind(C, name="_wrap_TpetraReader_readSparseFile__SWIG_5") & result(fresult) use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper -import :: SwigArrayWrapper +import :: swigclasswrapper +import :: swigarraywrapper type(SwigArrayWrapper) :: farg1 type(SwigClassWrapper) :: farg2 type(SwigClassWrapper) :: farg3 @@ -4403,8 +4395,8 @@ function swigc_TpetraReader_readSparseFile__SWIG_6(farg1, farg2, farg3, farg4) & bind(C, name="_wrap_TpetraReader_readSparseFile__SWIG_6") & result(fresult) use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper -import :: SwigArrayWrapper +import :: swigclasswrapper +import :: swigarraywrapper type(SwigArrayWrapper) :: farg1 type(SwigClassWrapper) :: farg2 type(SwigClassWrapper) :: farg3 @@ -4416,8 +4408,8 @@ function swigc_TpetraReader_readSparseFile__SWIG_7(farg1, farg2, farg3, farg4, f bind(C, name="_wrap_TpetraReader_readSparseFile__SWIG_7") & result(fresult) use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper -import :: SwigArrayWrapper +import :: swigclasswrapper +import :: swigarraywrapper type(SwigArrayWrapper) :: farg1 type(SwigClassWrapper) :: farg2 type(SwigClassWrapper) :: farg3 @@ -4433,8 +4425,8 @@ function swigc_TpetraReader_readSparseFile__SWIG_8(farg1, farg2, farg3, farg4, f bind(C, name="_wrap_TpetraReader_readSparseFile__SWIG_8") & result(fresult) use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper -import :: SwigArrayWrapper +import :: swigclasswrapper +import :: swigarraywrapper type(SwigArrayWrapper) :: farg1 type(SwigClassWrapper) :: farg2 type(SwigClassWrapper) :: farg3 @@ -4449,8 +4441,8 @@ function swigc_TpetraReader_readSparseFile__SWIG_9(farg1, farg2, farg3, farg4, f bind(C, name="_wrap_TpetraReader_readSparseFile__SWIG_9") & result(fresult) use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper -import :: SwigArrayWrapper +import :: swigclasswrapper +import :: swigarraywrapper type(SwigArrayWrapper) :: farg1 type(SwigClassWrapper) :: farg2 type(SwigClassWrapper) :: farg3 @@ -4464,8 +4456,8 @@ function swigc_TpetraReader_readSparseFile__SWIG_10(farg1, farg2, farg3, farg4, bind(C, name="_wrap_TpetraReader_readSparseFile__SWIG_10") & result(fresult) use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper -import :: SwigArrayWrapper +import :: swigclasswrapper +import :: swigarraywrapper type(SwigArrayWrapper) :: farg1 type(SwigClassWrapper) :: farg2 type(SwigClassWrapper) :: farg3 @@ -4478,8 +4470,8 @@ function swigc_TpetraReader_readDenseFile__SWIG_0(farg1, farg2, farg3, farg4, fa bind(C, name="_wrap_TpetraReader_readDenseFile__SWIG_0") & result(fresult) use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper -import :: SwigArrayWrapper +import :: swigclasswrapper +import :: swigarraywrapper type(SwigArrayWrapper) :: farg1 type(SwigClassWrapper) :: farg2 type(SwigClassWrapper) :: farg3 @@ -4492,8 +4484,8 @@ function swigc_TpetraReader_readDenseFile__SWIG_1(farg1, farg2, farg3, farg4) & bind(C, name="_wrap_TpetraReader_readDenseFile__SWIG_1") & result(fresult) use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper -import :: SwigArrayWrapper +import :: swigclasswrapper +import :: swigarraywrapper type(SwigArrayWrapper) :: farg1 type(SwigClassWrapper) :: farg2 type(SwigClassWrapper) :: farg3 @@ -4505,8 +4497,8 @@ function swigc_TpetraReader_readDenseFile__SWIG_2(farg1, farg2, farg3) & bind(C, name="_wrap_TpetraReader_readDenseFile__SWIG_2") & result(fresult) use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper -import :: SwigArrayWrapper +import :: swigclasswrapper +import :: swigarraywrapper type(SwigArrayWrapper) :: farg1 type(SwigClassWrapper) :: farg2 type(SwigClassWrapper) :: farg3 @@ -4517,8 +4509,8 @@ function swigc_TpetraReader_readMapFile__SWIG_0(farg1, farg2, farg3, farg4) & bind(C, name="_wrap_TpetraReader_readMapFile__SWIG_0") & result(fresult) use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper -import :: SwigArrayWrapper +import :: swigclasswrapper +import :: swigarraywrapper type(SwigArrayWrapper) :: farg1 type(SwigClassWrapper) :: farg2 logical(C_BOOL), intent(in) :: farg3 @@ -4530,8 +4522,8 @@ function swigc_TpetraReader_readMapFile__SWIG_1(farg1, farg2, farg3) & bind(C, name="_wrap_TpetraReader_readMapFile__SWIG_1") & result(fresult) use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper -import :: SwigArrayWrapper +import :: swigclasswrapper +import :: swigarraywrapper type(SwigArrayWrapper) :: farg1 type(SwigClassWrapper) :: farg2 logical(C_BOOL), intent(in) :: farg3 @@ -4542,8 +4534,8 @@ function swigc_TpetraReader_readMapFile__SWIG_2(farg1, farg2) & bind(C, name="_wrap_TpetraReader_readMapFile__SWIG_2") & result(fresult) use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper -import :: SwigArrayWrapper +import :: swigclasswrapper +import :: swigarraywrapper type(SwigArrayWrapper) :: farg1 type(SwigClassWrapper) :: farg2 type(SwigClassWrapper) :: fresult @@ -4553,14 +4545,14 @@ function swigc_new_TpetraReader() & bind(C, name="_wrap_new_TpetraReader") & result(fresult) use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: fresult end function subroutine swigc_delete_TpetraReader(farg1) & bind(C, name="_wrap_delete_TpetraReader") use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 end subroutine @@ -4574,8 +4566,8 @@ subroutine swigc_assignment_TpetraReader(self, other) & subroutine swigc_TpetraWriter_writeMapFile(farg1, farg2) & bind(C, name="_wrap_TpetraWriter_writeMapFile") use, intrinsic :: ISO_C_BINDING -import :: SwigArrayWrapper -import :: SwigClassWrapper +import :: swigarraywrapper +import :: swigclasswrapper type(SwigArrayWrapper) :: farg1 type(SwigClassWrapper) :: farg2 end subroutine @@ -4583,8 +4575,8 @@ subroutine swigc_TpetraWriter_writeMapFile(farg1, farg2) & subroutine swigc_TpetraWriter_writeSparseFile__SWIG_0(farg1, farg2, farg3, farg4, farg5) & bind(C, name="_wrap_TpetraWriter_writeSparseFile__SWIG_0") use, intrinsic :: ISO_C_BINDING -import :: SwigArrayWrapper -import :: SwigClassWrapper +import :: swigarraywrapper +import :: swigclasswrapper type(SwigArrayWrapper) :: farg1 type(SwigClassWrapper) :: farg2 type(SwigArrayWrapper) :: farg3 @@ -4595,8 +4587,8 @@ subroutine swigc_TpetraWriter_writeSparseFile__SWIG_0(farg1, farg2, farg3, farg4 subroutine swigc_TpetraWriter_writeSparseFile__SWIG_1(farg1, farg2, farg3, farg4) & bind(C, name="_wrap_TpetraWriter_writeSparseFile__SWIG_1") use, intrinsic :: ISO_C_BINDING -import :: SwigArrayWrapper -import :: SwigClassWrapper +import :: swigarraywrapper +import :: swigclasswrapper type(SwigArrayWrapper) :: farg1 type(SwigClassWrapper) :: farg2 type(SwigArrayWrapper) :: farg3 @@ -4606,8 +4598,8 @@ subroutine swigc_TpetraWriter_writeSparseFile__SWIG_1(farg1, farg2, farg3, farg4 subroutine swigc_TpetraWriter_writeSparseFile__SWIG_2(farg1, farg2, farg3) & bind(C, name="_wrap_TpetraWriter_writeSparseFile__SWIG_2") use, intrinsic :: ISO_C_BINDING -import :: SwigArrayWrapper -import :: SwigClassWrapper +import :: swigarraywrapper +import :: swigclasswrapper type(SwigArrayWrapper) :: farg1 type(SwigClassWrapper) :: farg2 logical(C_BOOL), intent(in) :: farg3 @@ -4616,8 +4608,8 @@ subroutine swigc_TpetraWriter_writeSparseFile__SWIG_2(farg1, farg2, farg3) & subroutine swigc_TpetraWriter_writeSparseFile__SWIG_3(farg1, farg2) & bind(C, name="_wrap_TpetraWriter_writeSparseFile__SWIG_3") use, intrinsic :: ISO_C_BINDING -import :: SwigArrayWrapper -import :: SwigClassWrapper +import :: swigarraywrapper +import :: swigclasswrapper type(SwigArrayWrapper) :: farg1 type(SwigClassWrapper) :: farg2 end subroutine @@ -4625,8 +4617,8 @@ subroutine swigc_TpetraWriter_writeSparseFile__SWIG_3(farg1, farg2) & subroutine swigc_TpetraWriter_writeSparseGraphFile__SWIG_0(farg1, farg2, farg3, farg4, farg5) & bind(C, name="_wrap_TpetraWriter_writeSparseGraphFile__SWIG_0") use, intrinsic :: ISO_C_BINDING -import :: SwigArrayWrapper -import :: SwigClassWrapper +import :: swigarraywrapper +import :: swigclasswrapper type(SwigArrayWrapper) :: farg1 type(SwigClassWrapper) :: farg2 type(SwigArrayWrapper) :: farg3 @@ -4637,8 +4629,8 @@ subroutine swigc_TpetraWriter_writeSparseGraphFile__SWIG_0(farg1, farg2, farg3, subroutine swigc_TpetraWriter_writeSparseGraphFile__SWIG_1(farg1, farg2, farg3, farg4) & bind(C, name="_wrap_TpetraWriter_writeSparseGraphFile__SWIG_1") use, intrinsic :: ISO_C_BINDING -import :: SwigArrayWrapper -import :: SwigClassWrapper +import :: swigarraywrapper +import :: swigclasswrapper type(SwigArrayWrapper) :: farg1 type(SwigClassWrapper) :: farg2 type(SwigArrayWrapper) :: farg3 @@ -4648,8 +4640,8 @@ subroutine swigc_TpetraWriter_writeSparseGraphFile__SWIG_1(farg1, farg2, farg3, subroutine swigc_TpetraWriter_writeSparseGraphFile__SWIG_2(farg1, farg2, farg3) & bind(C, name="_wrap_TpetraWriter_writeSparseGraphFile__SWIG_2") use, intrinsic :: ISO_C_BINDING -import :: SwigArrayWrapper -import :: SwigClassWrapper +import :: swigarraywrapper +import :: swigclasswrapper type(SwigArrayWrapper) :: farg1 type(SwigClassWrapper) :: farg2 logical(C_BOOL), intent(in) :: farg3 @@ -4658,8 +4650,8 @@ subroutine swigc_TpetraWriter_writeSparseGraphFile__SWIG_2(farg1, farg2, farg3) subroutine swigc_TpetraWriter_writeSparseGraphFile__SWIG_3(farg1, farg2) & bind(C, name="_wrap_TpetraWriter_writeSparseGraphFile__SWIG_3") use, intrinsic :: ISO_C_BINDING -import :: SwigArrayWrapper -import :: SwigClassWrapper +import :: swigarraywrapper +import :: swigclasswrapper type(SwigArrayWrapper) :: farg1 type(SwigClassWrapper) :: farg2 end subroutine @@ -4667,8 +4659,8 @@ subroutine swigc_TpetraWriter_writeSparseGraphFile__SWIG_3(farg1, farg2) & subroutine swigc_TpetraWriter_writeDenseFile__SWIG_0(farg1, farg2, farg3, farg4) & bind(C, name="_wrap_TpetraWriter_writeDenseFile__SWIG_0") use, intrinsic :: ISO_C_BINDING -import :: SwigArrayWrapper -import :: SwigClassWrapper +import :: swigarraywrapper +import :: swigclasswrapper type(SwigArrayWrapper) :: farg1 type(SwigClassWrapper) :: farg2 type(SwigArrayWrapper) :: farg3 @@ -4678,8 +4670,8 @@ subroutine swigc_TpetraWriter_writeDenseFile__SWIG_0(farg1, farg2, farg3, farg4) subroutine swigc_TpetraWriter_writeDenseFile__SWIG_1(farg1, farg2) & bind(C, name="_wrap_TpetraWriter_writeDenseFile__SWIG_1") use, intrinsic :: ISO_C_BINDING -import :: SwigArrayWrapper -import :: SwigClassWrapper +import :: swigarraywrapper +import :: swigclasswrapper type(SwigArrayWrapper) :: farg1 type(SwigClassWrapper) :: farg2 end subroutine @@ -4688,14 +4680,14 @@ function swigc_new_TpetraWriter() & bind(C, name="_wrap_new_TpetraWriter") & result(fresult) use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: fresult end function subroutine swigc_delete_TpetraWriter(farg1) & bind(C, name="_wrap_delete_TpetraWriter") use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 end subroutine @@ -4709,8 +4701,8 @@ subroutine swigc_assignment_TpetraWriter(self, other) & subroutine swigc_TpetraMatrixMatrixMultiply__SWIG_0(farg1, farg2, farg3, farg4, farg5, farg6, farg7, farg8) & bind(C, name="_wrap_TpetraMatrixMatrixMultiply__SWIG_0") use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper -import :: SwigArrayWrapper +import :: swigclasswrapper +import :: swigarraywrapper type(SwigClassWrapper) :: farg1 logical(C_BOOL), intent(in) :: farg2 type(SwigClassWrapper) :: farg3 @@ -4724,8 +4716,8 @@ subroutine swigc_TpetraMatrixMatrixMultiply__SWIG_0(farg1, farg2, farg3, farg4, subroutine swigc_TpetraMatrixMatrixMultiply__SWIG_1(farg1, farg2, farg3, farg4, farg5, farg6, farg7) & bind(C, name="_wrap_TpetraMatrixMatrixMultiply__SWIG_1") use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper -import :: SwigArrayWrapper +import :: swigclasswrapper +import :: swigarraywrapper type(SwigClassWrapper) :: farg1 logical(C_BOOL), intent(in) :: farg2 type(SwigClassWrapper) :: farg3 @@ -4738,7 +4730,7 @@ subroutine swigc_TpetraMatrixMatrixMultiply__SWIG_1(farg1, farg2, farg3, farg4, subroutine swigc_TpetraMatrixMatrixMultiply__SWIG_2(farg1, farg2, farg3, farg4, farg5, farg6) & bind(C, name="_wrap_TpetraMatrixMatrixMultiply__SWIG_2") use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 logical(C_BOOL), intent(in) :: farg2 type(SwigClassWrapper) :: farg3 @@ -4750,7 +4742,7 @@ subroutine swigc_TpetraMatrixMatrixMultiply__SWIG_2(farg1, farg2, farg3, farg4, subroutine swigc_TpetraMatrixMatrixMultiply__SWIG_3(farg1, farg2, farg3, farg4, farg5) & bind(C, name="_wrap_TpetraMatrixMatrixMultiply__SWIG_3") use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 logical(C_BOOL), intent(in) :: farg2 type(SwigClassWrapper) :: farg3 @@ -4761,7 +4753,7 @@ subroutine swigc_TpetraMatrixMatrixMultiply__SWIG_3(farg1, farg2, farg3, farg4, subroutine swigc_TpetraMatrixMatrixAdd__SWIG_0(farg1, farg2, farg3, farg4, farg5) & bind(C, name="_wrap_TpetraMatrixMatrixAdd__SWIG_0") use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 logical(C_BOOL), intent(in) :: farg2 real(C_DOUBLE), intent(in) :: farg3 @@ -4772,7 +4764,7 @@ subroutine swigc_TpetraMatrixMatrixAdd__SWIG_0(farg1, farg2, farg3, farg4, farg5 subroutine swigc_TpetraMatrixMatrixAdd__SWIG_1(farg1, farg2, farg3, farg4, farg5, farg6, farg7) & bind(C, name="_wrap_TpetraMatrixMatrixAdd__SWIG_1") use, intrinsic :: ISO_C_BINDING -import :: SwigClassWrapper +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 logical(C_BOOL), intent(in) :: farg2 real(C_DOUBLE), intent(in) :: farg3 @@ -4782,11 +4774,11 @@ subroutine swigc_TpetraMatrixMatrixAdd__SWIG_1(farg1, farg2, farg3, farg4, farg5 type(SwigClassWrapper) :: farg7 end subroutine - end interface +end interface contains - ! FORTRAN PROXY CODE + ! MODULE SUBPROGRAMS subroutine SWIG_string_to_chararray(string, chars, wrap) use, intrinsic :: ISO_C_BINDING @@ -4808,8 +4800,10 @@ subroutine SWIG_string_to_chararray(string, chars, wrap) subroutine setCombineModeParameter(plist, paramname) use, intrinsic :: ISO_C_BINDING class(ParameterList), intent(inout) :: plist + character(kind=C_CHAR, len=*), target :: paramname character(kind=C_CHAR), dimension(:), allocatable, target :: farg2_chars + type(SwigClassWrapper) :: farg1 type(SwigArrayWrapper) :: farg2 @@ -4836,9 +4830,10 @@ function combineModeToString(combinemode) & result(swig_result) use, intrinsic :: ISO_C_BINDING character(kind=C_CHAR, len=:), allocatable :: swig_result -integer(kind(TpetraCombineMode)), intent(in) :: combinemode -type(SwigArrayWrapper) :: fresult -integer(C_INT) :: farg1 +integer(TpetraCombineMode), intent(in) :: combinemode + +type(SwigArrayWrapper) :: fresult +integer(C_INT) :: farg1 farg1 = combinemode fresult = swigc_combineModeToString(farg1) @@ -4850,6 +4845,7 @@ function new_TpetraMap__SWIG_0() & result(self) use, intrinsic :: ISO_C_BINDING type(TpetraMap) :: self + type(SwigClassWrapper) :: fresult fresult = swigc_new_TpetraMap__SWIG_0() @@ -4859,13 +4855,14 @@ function new_TpetraMap__SWIG_0() & subroutine delete_TpetraMap(self) use, intrinsic :: ISO_C_BINDING class(TpetraMap), intent(inout) :: self + type(SwigClassWrapper) :: farg1 farg1 = self%swigdata if (self%swigdata%mem == SWIG_OWN) then call swigc_delete_TpetraMap(farg1) end if -self%swigdata%ptr = C_NULL_PTR +self%swigdata%cptr = C_NULL_PTR self%swigdata%mem = SWIG_NULL end subroutine @@ -4874,6 +4871,7 @@ function swigf_TpetraMap_isOneToOne(self) & use, intrinsic :: ISO_C_BINDING logical(C_BOOL) :: swig_result class(TpetraMap), intent(in) :: self + logical(C_BOOL) :: fresult type(SwigClassWrapper) :: farg1 @@ -4887,6 +4885,7 @@ function swigf_TpetraMap_getGlobalNumElements(self) & use, intrinsic :: ISO_C_BINDING integer(C_LONG) :: swig_result class(TpetraMap), intent(in) :: self + integer(C_LONG) :: fresult type(SwigClassWrapper) :: farg1 @@ -4900,6 +4899,7 @@ function swigf_TpetraMap_getNodeNumElements(self) & use, intrinsic :: ISO_C_BINDING integer(C_SIZE_T) :: swig_result class(TpetraMap), intent(in) :: self + integer(C_SIZE_T) :: fresult type(SwigClassWrapper) :: farg1 @@ -4913,6 +4913,7 @@ function swigf_TpetraMap_getMinLocalIndex(self) & use, intrinsic :: ISO_C_BINDING integer(C_INT) :: swig_result class(TpetraMap), intent(in) :: self + integer(C_INT) :: fresult type(SwigClassWrapper) :: farg1 @@ -4926,6 +4927,7 @@ function swigf_TpetraMap_getMaxLocalIndex(self) & use, intrinsic :: ISO_C_BINDING integer(C_INT) :: swig_result class(TpetraMap), intent(in) :: self + integer(C_INT) :: fresult type(SwigClassWrapper) :: farg1 @@ -4939,6 +4941,7 @@ function swigf_TpetraMap_getMinGlobalIndex(self) & use, intrinsic :: ISO_C_BINDING integer(C_LONG_LONG) :: swig_result class(TpetraMap), intent(in) :: self + integer(C_LONG_LONG) :: fresult type(SwigClassWrapper) :: farg1 @@ -4952,6 +4955,7 @@ function swigf_TpetraMap_getMaxGlobalIndex(self) & use, intrinsic :: ISO_C_BINDING integer(C_LONG_LONG) :: swig_result class(TpetraMap), intent(in) :: self + integer(C_LONG_LONG) :: fresult type(SwigClassWrapper) :: farg1 @@ -4965,6 +4969,7 @@ function swigf_TpetraMap_getMinAllGlobalIndex(self) & use, intrinsic :: ISO_C_BINDING integer(C_LONG_LONG) :: swig_result class(TpetraMap), intent(in) :: self + integer(C_LONG_LONG) :: fresult type(SwigClassWrapper) :: farg1 @@ -4978,6 +4983,7 @@ function swigf_TpetraMap_getMaxAllGlobalIndex(self) & use, intrinsic :: ISO_C_BINDING integer(C_LONG_LONG) :: swig_result class(TpetraMap), intent(in) :: self + integer(C_LONG_LONG) :: fresult type(SwigClassWrapper) :: farg1 @@ -4991,7 +4997,9 @@ function swigf_TpetraMap_getLocalElement(self, globalindex) & use, intrinsic :: ISO_C_BINDING integer(C_INT) :: swig_result class(TpetraMap), intent(in) :: self + integer(C_LONG_LONG), intent(in) :: globalindex + integer(C_INT) :: fresult type(SwigClassWrapper) :: farg1 integer(C_LONG_LONG) :: farg2 @@ -5007,7 +5015,9 @@ function swigf_TpetraMap_getGlobalElement(self, localindex) & use, intrinsic :: ISO_C_BINDING integer(C_LONG_LONG) :: swig_result class(TpetraMap), intent(in) :: self + integer(C_INT), intent(in) :: localindex + integer(C_LONG_LONG) :: fresult type(SwigClassWrapper) :: farg1 integer(C_INT) :: farg2 @@ -5023,7 +5033,9 @@ function swigf_TpetraMap_isNodeLocalElement(self, localindex) & use, intrinsic :: ISO_C_BINDING logical(C_BOOL) :: swig_result class(TpetraMap), intent(in) :: self + integer(C_INT), intent(in) :: localindex + logical(C_BOOL) :: fresult type(SwigClassWrapper) :: farg1 integer(C_INT) :: farg2 @@ -5039,7 +5051,9 @@ function swigf_TpetraMap_isNodeGlobalElement(self, globalindex) & use, intrinsic :: ISO_C_BINDING logical(C_BOOL) :: swig_result class(TpetraMap), intent(in) :: self + integer(C_LONG_LONG), intent(in) :: globalindex + logical(C_BOOL) :: fresult type(SwigClassWrapper) :: farg1 integer(C_LONG_LONG) :: farg2 @@ -5055,6 +5069,7 @@ function swigf_TpetraMap_isUniform(self) & use, intrinsic :: ISO_C_BINDING logical(C_BOOL) :: swig_result class(TpetraMap), intent(in) :: self + logical(C_BOOL) :: fresult type(SwigClassWrapper) :: farg1 @@ -5068,6 +5083,7 @@ function swigf_TpetraMap_isContiguous(self) & use, intrinsic :: ISO_C_BINDING logical(C_BOOL) :: swig_result class(TpetraMap), intent(in) :: self + logical(C_BOOL) :: fresult type(SwigClassWrapper) :: farg1 @@ -5081,6 +5097,7 @@ function swigf_TpetraMap_isDistributed(self) & use, intrinsic :: ISO_C_BINDING logical(C_BOOL) :: swig_result class(TpetraMap), intent(in) :: self + logical(C_BOOL) :: fresult type(SwigClassWrapper) :: farg1 @@ -5094,7 +5111,9 @@ function swigf_TpetraMap_isCompatible(self, map) & use, intrinsic :: ISO_C_BINDING logical(C_BOOL) :: swig_result class(TpetraMap), intent(in) :: self + class(TpetraMap), intent(in) :: map + logical(C_BOOL) :: fresult type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 @@ -5110,7 +5129,9 @@ function swigf_TpetraMap_isSameAs(self, map) & use, intrinsic :: ISO_C_BINDING logical(C_BOOL) :: swig_result class(TpetraMap), intent(in) :: self + class(TpetraMap), intent(in) :: map + logical(C_BOOL) :: fresult type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 @@ -5126,7 +5147,9 @@ function swigf_TpetraMap_locallySameAs(self, map) & use, intrinsic :: ISO_C_BINDING logical(C_BOOL) :: swig_result class(TpetraMap), intent(in) :: self + class(TpetraMap), intent(in) :: map + logical(C_BOOL) :: fresult type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 @@ -5142,10 +5165,12 @@ function swigf_TpetraMap_isLocallyFitted(self, map) & use, intrinsic :: ISO_C_BINDING logical(C_BOOL) :: swig_result class(TpetraMap), intent(in) :: self + class(TpetraMap), intent(in) :: map -logical(C_BOOL) :: fresult -type(SwigClassWrapper) :: farg1 -type(SwigClassWrapper) :: farg2 + +logical(C_BOOL) :: fresult +type(SwigClassWrapper) :: farg1 +type(SwigClassWrapper) :: farg2 farg1 = self%swigdata farg2 = map%swigdata @@ -5158,6 +5183,7 @@ function swigf_TpetraMap_getComm(self) & use, intrinsic :: ISO_C_BINDING type(TeuchosComm) :: swig_result class(TpetraMap), intent(in) :: self + type(SwigClassWrapper) :: fresult type(SwigClassWrapper) :: farg1 @@ -5171,6 +5197,7 @@ function swigf_TpetraMap_description(self) & use, intrinsic :: ISO_C_BINDING character(kind=C_CHAR, len=:), allocatable :: swig_result class(TpetraMap), intent(in) :: self + type(SwigArrayWrapper) :: fresult type(SwigClassWrapper) :: farg1 @@ -5185,6 +5212,7 @@ function swigf_TpetraMap_removeEmptyProcesses(self) & use, intrinsic :: ISO_C_BINDING type(TpetraMap) :: swig_result class(TpetraMap), intent(in) :: self + type(SwigClassWrapper) :: fresult type(SwigClassWrapper) :: farg1 @@ -5198,7 +5226,9 @@ function swigf_TpetraMap_replaceCommWithSubset(self, newcomm) & use, intrinsic :: ISO_C_BINDING type(TpetraMap) :: swig_result class(TpetraMap), intent(in) :: self + class(TeuchosComm), intent(in) :: newcomm + type(SwigClassWrapper) :: fresult type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 @@ -5215,7 +5245,9 @@ function new_TpetraMap__SWIG_1(numglobalelements, comm, lg) & type(TpetraMap) :: self integer(C_LONG), intent(in) :: numglobalelements class(TeuchosComm), intent(in) :: comm -integer(kind(TpetraLocalGlobal)), intent(in) :: lg + +integer(TpetraLocalGlobal), intent(in) :: lg + type(SwigClassWrapper) :: fresult integer(C_LONG) :: farg1 type(SwigClassWrapper) :: farg2 @@ -5234,6 +5266,7 @@ function new_TpetraMap__SWIG_2(numglobalelements, comm) & type(TpetraMap) :: self integer(C_LONG), intent(in) :: numglobalelements class(TeuchosComm), intent(in) :: comm + type(SwigClassWrapper) :: fresult integer(C_LONG) :: farg1 type(SwigClassWrapper) :: farg2 @@ -5251,6 +5284,7 @@ function new_TpetraMap__SWIG_3(numglobalelements, numlocalelements, comm) & integer(C_LONG), intent(in) :: numglobalelements integer(C_SIZE_T), intent(in) :: numlocalelements class(TeuchosComm), intent(in) :: comm + type(SwigClassWrapper) :: fresult integer(C_LONG) :: farg1 integer(C_SIZE_T) :: farg2 @@ -5271,6 +5305,7 @@ function new_TpetraMap__SWIG_4(numglobalelements, indexlist, comm) & integer(C_LONG_LONG), dimension(:), target :: indexlist integer(C_LONG_LONG), pointer :: farg2_view class(TeuchosComm), intent(in) :: comm + type(SwigClassWrapper) :: fresult integer(C_LONG) :: farg1 type(SwigArrayWrapper) :: farg2 @@ -5288,14 +5323,16 @@ function new_TpetraMap__SWIG_4(numglobalelements, indexlist, comm) & function swigf_TpetraMap_getRemoteIndexList__SWIG_0(self, gidlist, nodeidlist, lidlist) & result(swig_result) use, intrinsic :: ISO_C_BINDING -integer(kind(TpetraLookupStatus)) :: swig_result +integer(TpetraLookupStatus) :: swig_result class(TpetraMap), intent(in) :: self + integer(C_LONG_LONG), dimension(:), target :: gidlist integer(C_LONG_LONG), pointer :: farg2_view integer(C_INT), dimension(:), target :: nodeidlist integer(C_INT), pointer :: farg3_view integer(C_INT), dimension(:), target :: lidlist integer(C_INT), pointer :: farg4_view + integer(C_INT) :: fresult type(SwigClassWrapper) :: farg1 type(SwigArrayWrapper) :: farg2 @@ -5319,12 +5356,14 @@ function swigf_TpetraMap_getRemoteIndexList__SWIG_0(self, gidlist, nodeidlist, l function swigf_TpetraMap_getRemoteIndexList__SWIG_1(self, gidlist, nodeidlist) & result(swig_result) use, intrinsic :: ISO_C_BINDING -integer(kind(TpetraLookupStatus)) :: swig_result +integer(TpetraLookupStatus) :: swig_result class(TpetraMap), intent(in) :: self + integer(C_LONG_LONG), dimension(:), target :: gidlist integer(C_LONG_LONG), pointer :: farg2_view integer(C_INT), dimension(:), target :: nodeidlist integer(C_INT), pointer :: farg3_view + integer(C_INT) :: fresult type(SwigClassWrapper) :: farg1 type(SwigArrayWrapper) :: farg2 @@ -5346,6 +5385,7 @@ function swigf_TpetraMap_getNodeElementList(self) & use, intrinsic :: ISO_C_BINDING integer(C_LONG_LONG), dimension(:), pointer :: swig_result class(TpetraMap), intent(in) :: self + type(SwigArrayWrapper) :: fresult type(SwigClassWrapper) :: farg1 @@ -5365,7 +5405,9 @@ function new_TpetraExport__SWIG_0(source, target) & use, intrinsic :: ISO_C_BINDING type(TpetraExport) :: self class(TpetraMap), intent(in) :: source + class(TpetraMap), intent(in) :: target + type(SwigClassWrapper) :: fresult type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 @@ -5381,8 +5423,11 @@ function new_TpetraExport__SWIG_1(source, target, plist) & use, intrinsic :: ISO_C_BINDING type(TpetraExport) :: self class(TpetraMap), intent(in) :: source + class(TpetraMap), intent(in) :: target + class(ParameterList), intent(in) :: plist + type(SwigClassWrapper) :: fresult type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 @@ -5400,6 +5445,7 @@ function new_TpetraExport__SWIG_2(rhs) & use, intrinsic :: ISO_C_BINDING type(TpetraExport) :: self class(TpetraExport), intent(in) :: rhs + type(SwigClassWrapper) :: fresult type(SwigClassWrapper) :: farg1 @@ -5412,7 +5458,8 @@ function new_TpetraExport__SWIG_3(importer) & result(self) use, intrinsic :: ISO_C_BINDING type(TpetraExport) :: self -class(SwigUnknownClass), intent(in) :: importer +class(SWIGTYPE_ImportT_int_long_long_Kokkos__Compat__KokkosSeri1YW4XR), intent(in) :: importer + type(SwigClassWrapper) :: fresult type(SwigClassWrapper) :: farg1 @@ -5424,20 +5471,23 @@ function new_TpetraExport__SWIG_3(importer) & subroutine delete_TpetraExport(self) use, intrinsic :: ISO_C_BINDING class(TpetraExport), intent(inout) :: self + type(SwigClassWrapper) :: farg1 farg1 = self%swigdata if (self%swigdata%mem == SWIG_OWN) then call swigc_delete_TpetraExport(farg1) end if -self%swigdata%ptr = C_NULL_PTR +self%swigdata%cptr = C_NULL_PTR self%swigdata%mem = SWIG_NULL end subroutine subroutine swigf_TpetraExport_setParameterList(self, plist) use, intrinsic :: ISO_C_BINDING class(TpetraExport), intent(inout) :: self + class(ParameterList), intent(in) :: plist + type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 @@ -5451,6 +5501,7 @@ function swigf_TpetraExport_getNumSameIDs(self) & use, intrinsic :: ISO_C_BINDING integer(C_SIZE_T) :: swig_result class(TpetraExport), intent(in) :: self + integer(C_SIZE_T) :: fresult type(SwigClassWrapper) :: farg1 @@ -5464,6 +5515,7 @@ function swigf_TpetraExport_getNumPermuteIDs(self) & use, intrinsic :: ISO_C_BINDING integer(C_SIZE_T) :: swig_result class(TpetraExport), intent(in) :: self + integer(C_SIZE_T) :: fresult type(SwigClassWrapper) :: farg1 @@ -5477,6 +5529,7 @@ function swigf_TpetraExport_getNumRemoteIDs(self) & use, intrinsic :: ISO_C_BINDING integer(C_SIZE_T) :: swig_result class(TpetraExport), intent(in) :: self + integer(C_SIZE_T) :: fresult type(SwigClassWrapper) :: farg1 @@ -5490,6 +5543,7 @@ function swigf_TpetraExport_getNumExportIDs(self) & use, intrinsic :: ISO_C_BINDING integer(C_SIZE_T) :: swig_result class(TpetraExport), intent(in) :: self + integer(C_SIZE_T) :: fresult type(SwigClassWrapper) :: farg1 @@ -5503,6 +5557,7 @@ function swigf_TpetraExport_getSourceMap(self) & use, intrinsic :: ISO_C_BINDING type(TpetraMap) :: swig_result class(TpetraExport), intent(in) :: self + type(SwigClassWrapper) :: fresult type(SwigClassWrapper) :: farg1 @@ -5516,6 +5571,7 @@ function swigf_TpetraExport_getTargetMap(self) & use, intrinsic :: ISO_C_BINDING type(TpetraMap) :: swig_result class(TpetraExport), intent(in) :: self + type(SwigClassWrapper) :: fresult type(SwigClassWrapper) :: farg1 @@ -5529,6 +5585,7 @@ function swigf_TpetraExport_isLocallyComplete(self) & use, intrinsic :: ISO_C_BINDING logical(C_BOOL) :: swig_result class(TpetraExport), intent(in) :: self + logical(C_BOOL) :: fresult type(SwigClassWrapper) :: farg1 @@ -5548,7 +5605,9 @@ function new_TpetraImport__SWIG_0(source, target) & use, intrinsic :: ISO_C_BINDING type(TpetraImport) :: self class(TpetraMap), intent(in) :: source + class(TpetraMap), intent(in) :: target + type(SwigClassWrapper) :: fresult type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 @@ -5564,8 +5623,11 @@ function new_TpetraImport__SWIG_1(source, target, plist) & use, intrinsic :: ISO_C_BINDING type(TpetraImport) :: self class(TpetraMap), intent(in) :: source + class(TpetraMap), intent(in) :: target + class(ParameterList), intent(in) :: plist + type(SwigClassWrapper) :: fresult type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 @@ -5583,6 +5645,7 @@ function new_TpetraImport__SWIG_2(importer) & use, intrinsic :: ISO_C_BINDING type(TpetraImport) :: self class(TpetraImport), intent(in) :: importer + type(SwigClassWrapper) :: fresult type(SwigClassWrapper) :: farg1 @@ -5596,6 +5659,7 @@ function new_TpetraImport__SWIG_3(exporter) & use, intrinsic :: ISO_C_BINDING type(TpetraImport) :: self class(TpetraExport), intent(in) :: exporter + type(SwigClassWrapper) :: fresult type(SwigClassWrapper) :: farg1 @@ -5607,20 +5671,23 @@ function new_TpetraImport__SWIG_3(exporter) & subroutine delete_TpetraImport(self) use, intrinsic :: ISO_C_BINDING class(TpetraImport), intent(inout) :: self + type(SwigClassWrapper) :: farg1 farg1 = self%swigdata if (self%swigdata%mem == SWIG_OWN) then call swigc_delete_TpetraImport(farg1) end if -self%swigdata%ptr = C_NULL_PTR +self%swigdata%cptr = C_NULL_PTR self%swigdata%mem = SWIG_NULL end subroutine subroutine swigf_TpetraImport_setParameterList(self, plist) use, intrinsic :: ISO_C_BINDING class(TpetraImport), intent(inout) :: self + class(ParameterList), intent(in) :: plist + type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 @@ -5634,6 +5701,7 @@ function swigf_TpetraImport_getNumSameIDs(self) & use, intrinsic :: ISO_C_BINDING integer(C_SIZE_T) :: swig_result class(TpetraImport), intent(in) :: self + integer(C_SIZE_T) :: fresult type(SwigClassWrapper) :: farg1 @@ -5647,6 +5715,7 @@ function swigf_TpetraImport_getNumPermuteIDs(self) & use, intrinsic :: ISO_C_BINDING integer(C_SIZE_T) :: swig_result class(TpetraImport), intent(in) :: self + integer(C_SIZE_T) :: fresult type(SwigClassWrapper) :: farg1 @@ -5660,6 +5729,7 @@ function swigf_TpetraImport_getNumRemoteIDs(self) & use, intrinsic :: ISO_C_BINDING integer(C_SIZE_T) :: swig_result class(TpetraImport), intent(in) :: self + integer(C_SIZE_T) :: fresult type(SwigClassWrapper) :: farg1 @@ -5673,6 +5743,7 @@ function swigf_TpetraImport_getNumExportIDs(self) & use, intrinsic :: ISO_C_BINDING integer(C_SIZE_T) :: swig_result class(TpetraImport), intent(in) :: self + integer(C_SIZE_T) :: fresult type(SwigClassWrapper) :: farg1 @@ -5686,6 +5757,7 @@ function swigf_TpetraImport_getSourceMap(self) & use, intrinsic :: ISO_C_BINDING type(TpetraMap) :: swig_result class(TpetraImport), intent(in) :: self + type(SwigClassWrapper) :: fresult type(SwigClassWrapper) :: farg1 @@ -5699,6 +5771,7 @@ function swigf_TpetraImport_getTargetMap(self) & use, intrinsic :: ISO_C_BINDING type(TpetraMap) :: swig_result class(TpetraImport), intent(in) :: self + type(SwigClassWrapper) :: fresult type(SwigClassWrapper) :: farg1 @@ -5712,6 +5785,7 @@ function swigf_TpetraImport_isLocallyComplete(self) & use, intrinsic :: ISO_C_BINDING logical(C_BOOL) :: swig_result class(TpetraImport), intent(in) :: self + logical(C_BOOL) :: fresult type(SwigClassWrapper) :: farg1 @@ -5725,7 +5799,9 @@ function swigf_TpetraImport_setUnion__SWIG_0(self, rhs) & use, intrinsic :: ISO_C_BINDING type(TpetraImport) :: swig_result class(TpetraImport), intent(in) :: self + class(TpetraImport), intent(in) :: rhs + type(SwigClassWrapper) :: fresult type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 @@ -5741,6 +5817,7 @@ function swigf_TpetraImport_setUnion__SWIG_1(self) & use, intrinsic :: ISO_C_BINDING type(TpetraImport) :: swig_result class(TpetraImport), intent(in) :: self + type(SwigClassWrapper) :: fresult type(SwigClassWrapper) :: farg1 @@ -5754,7 +5831,9 @@ function swigf_TpetraImport_createRemoteOnlyImport(self, remotetarget) & use, intrinsic :: ISO_C_BINDING type(TpetraImport) :: swig_result class(TpetraImport), intent(in) :: self + class(TpetraMap), intent(in) :: remotetarget + type(SwigClassWrapper) :: fresult type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 @@ -5775,6 +5854,7 @@ function new_TpetraMultiVector__SWIG_0() & result(self) use, intrinsic :: ISO_C_BINDING type(TpetraMultiVector) :: self + type(SwigClassWrapper) :: fresult fresult = swigc_new_TpetraMultiVector__SWIG_0() @@ -5786,8 +5866,10 @@ function new_TpetraMultiVector__SWIG_1(map, numvecs, zeroout) & use, intrinsic :: ISO_C_BINDING type(TpetraMultiVector) :: self class(TpetraMap), intent(in) :: map + integer(C_SIZE_T), intent(in) :: numvecs logical(C_BOOL), intent(in) :: zeroout + type(SwigClassWrapper) :: fresult type(SwigClassWrapper) :: farg1 integer(C_SIZE_T) :: farg2 @@ -5805,7 +5887,9 @@ function new_TpetraMultiVector__SWIG_2(map, numvecs) & use, intrinsic :: ISO_C_BINDING type(TpetraMultiVector) :: self class(TpetraMap), intent(in) :: map + integer(C_SIZE_T), intent(in) :: numvecs + type(SwigClassWrapper) :: fresult type(SwigClassWrapper) :: farg1 integer(C_SIZE_T) :: farg2 @@ -5821,6 +5905,7 @@ function new_TpetraMultiVector__SWIG_3(source) & use, intrinsic :: ISO_C_BINDING type(TpetraMultiVector) :: self class(TpetraMultiVector), intent(in) :: source + type(SwigClassWrapper) :: fresult type(SwigClassWrapper) :: farg1 @@ -5834,7 +5919,9 @@ function new_TpetraMultiVector__SWIG_4(source, copyorview) & use, intrinsic :: ISO_C_BINDING type(TpetraMultiVector) :: self class(TpetraMultiVector), intent(in) :: source -integer(kind(TeuchosDataAccess)), intent(in) :: copyorview + +integer(SWIGTYPE_Teuchos__DataAccess), intent(in) :: copyorview + type(SwigClassWrapper) :: fresult type(SwigClassWrapper) :: farg1 integer(C_INT) :: farg2 @@ -5850,8 +5937,11 @@ function new_TpetraMultiVector__SWIG_6(x, submap, offset) & use, intrinsic :: ISO_C_BINDING type(TpetraMultiVector) :: self class(TpetraMultiVector), intent(in) :: x + class(TpetraMap), intent(in) :: submap + integer(C_SIZE_T), intent(in) :: offset + type(SwigClassWrapper) :: fresult type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 @@ -5869,7 +5959,9 @@ function new_TpetraMultiVector__SWIG_7(x, submap) & use, intrinsic :: ISO_C_BINDING type(TpetraMultiVector) :: self class(TpetraMultiVector), intent(in) :: x + class(TpetraMap), intent(in) :: submap + type(SwigClassWrapper) :: fresult type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 @@ -5883,9 +5975,11 @@ function new_TpetraMultiVector__SWIG_7(x, submap) & subroutine swigf_TpetraMultiVector_swap(self, mv) use, intrinsic :: ISO_C_BINDING class(TpetraMultiVector), intent(inout) :: self + class(TpetraMultiVector), intent(inout) :: mv -type(SwigClassWrapper) :: farg1 -type(SwigClassWrapper) :: farg2 + +type(SwigClassWrapper) :: farg1 +type(SwigClassWrapper) :: farg2 farg1 = self%swigdata farg2 = mv%swigdata @@ -5895,22 +5989,25 @@ subroutine swigf_TpetraMultiVector_swap(self, mv) subroutine delete_TpetraMultiVector(self) use, intrinsic :: ISO_C_BINDING class(TpetraMultiVector), intent(inout) :: self + type(SwigClassWrapper) :: farg1 farg1 = self%swigdata if (self%swigdata%mem == SWIG_OWN) then call swigc_delete_TpetraMultiVector(farg1) end if -self%swigdata%ptr = C_NULL_PTR +self%swigdata%cptr = C_NULL_PTR self%swigdata%mem = SWIG_NULL end subroutine subroutine swigf_TpetraMultiVector_replaceGlobalValue(self, gblrow, col, value) use, intrinsic :: ISO_C_BINDING class(TpetraMultiVector), intent(in) :: self + integer(C_LONG_LONG), intent(in) :: gblrow integer(C_SIZE_T), intent(in) :: col real(C_DOUBLE), intent(in) :: value + type(SwigClassWrapper) :: farg1 integer(C_LONG_LONG) :: farg2 integer(C_SIZE_T) :: farg3 @@ -5926,10 +6023,12 @@ subroutine swigf_TpetraMultiVector_replaceGlobalValue(self, gblrow, col, value) subroutine swigf_TpetraMultiVector_sumIntoGlobalValue__SWIG_0(self, gblrow, col, value, atomic) use, intrinsic :: ISO_C_BINDING class(TpetraMultiVector), intent(in) :: self + integer(C_LONG_LONG), intent(in) :: gblrow integer(C_SIZE_T), intent(in) :: col real(C_DOUBLE), intent(in) :: value logical(C_BOOL), intent(in) :: atomic + type(SwigClassWrapper) :: farg1 integer(C_LONG_LONG) :: farg2 integer(C_SIZE_T) :: farg3 @@ -5947,9 +6046,11 @@ subroutine swigf_TpetraMultiVector_sumIntoGlobalValue__SWIG_0(self, gblrow, col, subroutine swigf_TpetraMultiVector_sumIntoGlobalValue__SWIG_1(self, gblrow, col, value) use, intrinsic :: ISO_C_BINDING class(TpetraMultiVector), intent(in) :: self + integer(C_LONG_LONG), intent(in) :: gblrow integer(C_SIZE_T), intent(in) :: col real(C_DOUBLE), intent(in) :: value + type(SwigClassWrapper) :: farg1 integer(C_LONG_LONG) :: farg2 integer(C_SIZE_T) :: farg3 @@ -5965,9 +6066,11 @@ subroutine swigf_TpetraMultiVector_sumIntoGlobalValue__SWIG_1(self, gblrow, col, subroutine swigf_TpetraMultiVector_replaceLocalValue(self, lclrow, col, value) use, intrinsic :: ISO_C_BINDING class(TpetraMultiVector), intent(in) :: self + integer(C_INT), intent(in) :: lclrow integer(C_SIZE_T), intent(in) :: col real(C_DOUBLE), intent(in) :: value + type(SwigClassWrapper) :: farg1 integer(C_INT) :: farg2 integer(C_SIZE_T) :: farg3 @@ -5983,10 +6086,12 @@ subroutine swigf_TpetraMultiVector_replaceLocalValue(self, lclrow, col, value) subroutine swigf_TpetraMultiVector_sumIntoLocalValue__SWIG_0(self, lclrow, col, val, atomic) use, intrinsic :: ISO_C_BINDING class(TpetraMultiVector), intent(in) :: self + integer(C_INT), intent(in) :: lclrow integer(C_SIZE_T), intent(in) :: col real(C_DOUBLE), intent(in) :: val logical(C_BOOL), intent(in) :: atomic + type(SwigClassWrapper) :: farg1 integer(C_INT) :: farg2 integer(C_SIZE_T) :: farg3 @@ -6004,9 +6109,11 @@ subroutine swigf_TpetraMultiVector_sumIntoLocalValue__SWIG_0(self, lclrow, col, subroutine swigf_TpetraMultiVector_sumIntoLocalValue__SWIG_1(self, lclrow, col, val) use, intrinsic :: ISO_C_BINDING class(TpetraMultiVector), intent(in) :: self + integer(C_INT), intent(in) :: lclrow integer(C_SIZE_T), intent(in) :: col real(C_DOUBLE), intent(in) :: val + type(SwigClassWrapper) :: farg1 integer(C_INT) :: farg2 integer(C_SIZE_T) :: farg3 @@ -6022,7 +6129,9 @@ subroutine swigf_TpetraMultiVector_sumIntoLocalValue__SWIG_1(self, lclrow, col, subroutine swigf_TpetraMultiVector_putScalar(self, value) use, intrinsic :: ISO_C_BINDING class(TpetraMultiVector), intent(inout) :: self + real(C_DOUBLE), intent(in) :: value + type(SwigClassWrapper) :: farg1 real(C_DOUBLE) :: farg2 @@ -6034,6 +6143,7 @@ subroutine swigf_TpetraMultiVector_putScalar(self, value) subroutine swigf_TpetraMultiVector_randomize__SWIG_0(self) use, intrinsic :: ISO_C_BINDING class(TpetraMultiVector), intent(inout) :: self + type(SwigClassWrapper) :: farg1 farg1 = self%swigdata @@ -6043,8 +6153,10 @@ subroutine swigf_TpetraMultiVector_randomize__SWIG_0(self) subroutine swigf_TpetraMultiVector_randomize__SWIG_1(self, minval, maxval) use, intrinsic :: ISO_C_BINDING class(TpetraMultiVector), intent(inout) :: self + real(C_DOUBLE), intent(in) :: minval real(C_DOUBLE), intent(in) :: maxval + type(SwigClassWrapper) :: farg1 real(C_DOUBLE) :: farg2 real(C_DOUBLE) :: farg3 @@ -6058,7 +6170,9 @@ subroutine swigf_TpetraMultiVector_randomize__SWIG_1(self, minval, maxval) subroutine swigf_TpetraMultiVector_replaceMap(self, map) use, intrinsic :: ISO_C_BINDING class(TpetraMultiVector), intent(inout) :: self + class(TpetraMap), intent(in) :: map + type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 @@ -6070,6 +6184,7 @@ subroutine swigf_TpetraMultiVector_replaceMap(self, map) subroutine swigf_TpetraMultiVector_reduce(self) use, intrinsic :: ISO_C_BINDING class(TpetraMultiVector), intent(inout) :: self + type(SwigClassWrapper) :: farg1 farg1 = self%swigdata @@ -6081,8 +6196,11 @@ function swigf_TpetraMultiVector_offsetView(self, submap, offset) & use, intrinsic :: ISO_C_BINDING type(TpetraMultiVector) :: swig_result class(TpetraMultiVector), intent(in) :: self + class(TpetraMap), intent(in) :: submap + integer(C_SIZE_T), intent(in) :: offset + type(SwigClassWrapper) :: fresult type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 @@ -6100,8 +6218,11 @@ function swigf_TpetraMultiVector_offsetViewNonConst(self, submap, offset) & use, intrinsic :: ISO_C_BINDING type(TpetraMultiVector) :: swig_result class(TpetraMultiVector), intent(inout) :: self + class(TpetraMap), intent(in) :: submap + integer(C_SIZE_T), intent(in) :: offset + type(SwigClassWrapper) :: fresult type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 @@ -6117,7 +6238,8 @@ function swigf_TpetraMultiVector_offsetViewNonConst(self, submap, offset) & subroutine swigf_TpetraMultiVector_sync_host(self) use, intrinsic :: ISO_C_BINDING class(TpetraMultiVector), intent(inout) :: self -type(SwigClassWrapper) :: farg1 + +type(SwigClassWrapper) :: farg1 farg1 = self%swigdata call swigc_TpetraMultiVector_sync_host(farg1) @@ -6126,7 +6248,8 @@ subroutine swigf_TpetraMultiVector_sync_host(self) subroutine swigf_TpetraMultiVector_sync_device(self) use, intrinsic :: ISO_C_BINDING class(TpetraMultiVector), intent(inout) :: self -type(SwigClassWrapper) :: farg1 + +type(SwigClassWrapper) :: farg1 farg1 = self%swigdata call swigc_TpetraMultiVector_sync_device(farg1) @@ -6137,8 +6260,9 @@ function swigf_TpetraMultiVector_need_sync_host(self) & use, intrinsic :: ISO_C_BINDING logical(C_BOOL) :: swig_result class(TpetraMultiVector), intent(in) :: self -logical(C_BOOL) :: fresult -type(SwigClassWrapper) :: farg1 + +logical(C_BOOL) :: fresult +type(SwigClassWrapper) :: farg1 farg1 = self%swigdata fresult = swigc_TpetraMultiVector_need_sync_host(farg1) @@ -6150,8 +6274,9 @@ function swigf_TpetraMultiVector_need_sync_device(self) & use, intrinsic :: ISO_C_BINDING logical(C_BOOL) :: swig_result class(TpetraMultiVector), intent(in) :: self -logical(C_BOOL) :: fresult -type(SwigClassWrapper) :: farg1 + +logical(C_BOOL) :: fresult +type(SwigClassWrapper) :: farg1 farg1 = self%swigdata fresult = swigc_TpetraMultiVector_need_sync_device(farg1) @@ -6161,7 +6286,8 @@ function swigf_TpetraMultiVector_need_sync_device(self) & subroutine swigf_TpetraMultiVector_modify_device(self) use, intrinsic :: ISO_C_BINDING class(TpetraMultiVector), intent(inout) :: self -type(SwigClassWrapper) :: farg1 + +type(SwigClassWrapper) :: farg1 farg1 = self%swigdata call swigc_TpetraMultiVector_modify_device(farg1) @@ -6170,7 +6296,8 @@ subroutine swigf_TpetraMultiVector_modify_device(self) subroutine swigf_TpetraMultiVector_modify_host(self) use, intrinsic :: ISO_C_BINDING class(TpetraMultiVector), intent(inout) :: self -type(SwigClassWrapper) :: farg1 + +type(SwigClassWrapper) :: farg1 farg1 = self%swigdata call swigc_TpetraMultiVector_modify_host(farg1) @@ -6179,7 +6306,9 @@ subroutine swigf_TpetraMultiVector_modify_host(self) subroutine swigf_TpetraMultiVector_abs(self, a) use, intrinsic :: ISO_C_BINDING class(TpetraMultiVector), intent(inout) :: self + class(TpetraMultiVector), intent(in) :: a + type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 @@ -6191,7 +6320,9 @@ subroutine swigf_TpetraMultiVector_abs(self, a) subroutine swigf_TpetraMultiVector_reciprocal(self, a) use, intrinsic :: ISO_C_BINDING class(TpetraMultiVector), intent(inout) :: self + class(TpetraMultiVector), intent(in) :: a + type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 @@ -6203,7 +6334,9 @@ subroutine swigf_TpetraMultiVector_reciprocal(self, a) subroutine swigf_TpetraMultiVector_scale__SWIG_0(self, alpha) use, intrinsic :: ISO_C_BINDING class(TpetraMultiVector), intent(inout) :: self + real(C_DOUBLE), intent(in) :: alpha + type(SwigClassWrapper) :: farg1 real(C_DOUBLE) :: farg2 @@ -6215,8 +6348,10 @@ subroutine swigf_TpetraMultiVector_scale__SWIG_0(self, alpha) subroutine swigf_TpetraMultiVector_scale__SWIG_1(self, alpha, a) use, intrinsic :: ISO_C_BINDING class(TpetraMultiVector), intent(inout) :: self + real(C_DOUBLE), intent(in) :: alpha class(TpetraMultiVector), intent(in) :: a + type(SwigClassWrapper) :: farg1 real(C_DOUBLE) :: farg2 type(SwigClassWrapper) :: farg3 @@ -6230,9 +6365,12 @@ subroutine swigf_TpetraMultiVector_scale__SWIG_1(self, alpha, a) subroutine swigf_TpetraMultiVector_update__SWIG_0(self, alpha, a, beta) use, intrinsic :: ISO_C_BINDING class(TpetraMultiVector), intent(inout) :: self + real(C_DOUBLE), intent(in) :: alpha class(TpetraMultiVector), intent(in) :: a + real(C_DOUBLE), intent(in) :: beta + type(SwigClassWrapper) :: farg1 real(C_DOUBLE) :: farg2 type(SwigClassWrapper) :: farg3 @@ -6248,11 +6386,15 @@ subroutine swigf_TpetraMultiVector_update__SWIG_0(self, alpha, a, beta) subroutine swigf_TpetraMultiVector_update__SWIG_1(self, alpha, a, beta, b, gamma) use, intrinsic :: ISO_C_BINDING class(TpetraMultiVector), intent(inout) :: self + real(C_DOUBLE), intent(in) :: alpha class(TpetraMultiVector), intent(in) :: a + real(C_DOUBLE), intent(in) :: beta class(TpetraMultiVector), intent(in) :: b + real(C_DOUBLE), intent(in) :: gamma + type(SwigClassWrapper) :: farg1 real(C_DOUBLE) :: farg2 type(SwigClassWrapper) :: farg3 @@ -6272,12 +6414,16 @@ subroutine swigf_TpetraMultiVector_update__SWIG_1(self, alpha, a, beta, b, gamma subroutine swigf_TpetraMultiVector_multiply(self, transa, transb, alpha, a, b, beta) use, intrinsic :: ISO_C_BINDING class(TpetraMultiVector), intent(inout) :: self -integer(kind(TeuchosETransp)), intent(in) :: transa -integer(kind(TeuchosETransp)), intent(in) :: transb + +integer(SWIGTYPE_Teuchos__ETransp), intent(in) :: transa +integer(SWIGTYPE_Teuchos__ETransp), intent(in) :: transb real(C_DOUBLE), intent(in) :: alpha class(TpetraMultiVector), intent(in) :: a + class(TpetraMultiVector), intent(in) :: b + real(C_DOUBLE), intent(in) :: beta + type(SwigClassWrapper) :: farg1 integer(C_INT) :: farg2 integer(C_INT) :: farg3 @@ -6301,6 +6447,7 @@ function swigf_TpetraMultiVector_getNumVectors(self) & use, intrinsic :: ISO_C_BINDING integer(C_SIZE_T) :: swig_result class(TpetraMultiVector), intent(in) :: self + integer(C_SIZE_T) :: fresult type(SwigClassWrapper) :: farg1 @@ -6314,6 +6461,7 @@ function swigf_TpetraMultiVector_getLocalLength(self) & use, intrinsic :: ISO_C_BINDING integer(C_SIZE_T) :: swig_result class(TpetraMultiVector), intent(in) :: self + integer(C_SIZE_T) :: fresult type(SwigClassWrapper) :: farg1 @@ -6327,6 +6475,7 @@ function swigf_TpetraMultiVector_getGlobalLength(self) & use, intrinsic :: ISO_C_BINDING integer(C_LONG) :: swig_result class(TpetraMultiVector), intent(in) :: self + integer(C_LONG) :: fresult type(SwigClassWrapper) :: farg1 @@ -6340,6 +6489,7 @@ function swigf_TpetraMultiVector_getStride(self) & use, intrinsic :: ISO_C_BINDING integer(C_SIZE_T) :: swig_result class(TpetraMultiVector), intent(in) :: self + integer(C_SIZE_T) :: fresult type(SwigClassWrapper) :: farg1 @@ -6353,6 +6503,7 @@ function swigf_TpetraMultiVector_isConstantStride(self) & use, intrinsic :: ISO_C_BINDING logical(C_BOOL) :: swig_result class(TpetraMultiVector), intent(in) :: self + logical(C_BOOL) :: fresult type(SwigClassWrapper) :: farg1 @@ -6366,6 +6517,7 @@ function swigf_TpetraMultiVector_description(self) & use, intrinsic :: ISO_C_BINDING character(kind=C_CHAR, len=:), allocatable :: swig_result class(TpetraMultiVector), intent(in) :: self + type(SwigArrayWrapper) :: fresult type(SwigClassWrapper) :: farg1 @@ -6378,7 +6530,9 @@ function swigf_TpetraMultiVector_description(self) & subroutine swigf_TpetraMultiVector_removeEmptyProcessesInPlace(self, newmap) use, intrinsic :: ISO_C_BINDING class(TpetraMultiVector), intent(inout) :: self + class(TpetraMap), intent(in) :: newmap + type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 @@ -6390,7 +6544,9 @@ subroutine swigf_TpetraMultiVector_removeEmptyProcessesInPlace(self, newmap) subroutine swigf_TpetraMultiVector_setCopyOrView(self, copyorview) use, intrinsic :: ISO_C_BINDING class(TpetraMultiVector), intent(inout) :: self -integer(kind(TeuchosDataAccess)), intent(in) :: copyorview + +integer(SWIGTYPE_Teuchos__DataAccess), intent(in) :: copyorview + type(SwigClassWrapper) :: farg1 integer(C_INT) :: farg2 @@ -6402,8 +6558,9 @@ subroutine swigf_TpetraMultiVector_setCopyOrView(self, copyorview) function swigf_TpetraMultiVector_getCopyOrView(self) & result(swig_result) use, intrinsic :: ISO_C_BINDING -integer(kind(TeuchosDataAccess)) :: swig_result +integer(SWIGTYPE_Teuchos__DataAccess) :: swig_result class(TpetraMultiVector), intent(in) :: self + integer(C_INT) :: fresult type(SwigClassWrapper) :: farg1 @@ -6417,10 +6574,12 @@ function swigf_TpetraMultiVector_isSameSize(self, vec) & use, intrinsic :: ISO_C_BINDING logical(C_BOOL) :: swig_result class(TpetraMultiVector), intent(in) :: self + class(TpetraMultiVector), intent(in) :: vec -logical(C_BOOL) :: fresult -type(SwigClassWrapper) :: farg1 -type(SwigClassWrapper) :: farg2 + +logical(C_BOOL) :: fresult +type(SwigClassWrapper) :: farg1 +type(SwigClassWrapper) :: farg2 farg1 = self%swigdata farg2 = vec%swigdata @@ -6433,10 +6592,12 @@ function new_TpetraMultiVector__SWIG_8(map, a, lda, numvectors) & use, intrinsic :: ISO_C_BINDING type(TpetraMultiVector) :: self class(TpetraMap), intent(in) :: map + real(C_DOUBLE), dimension(:), target :: a real(C_DOUBLE), pointer :: farg2_view integer(C_SIZE_T), intent(in) :: lda integer(C_SIZE_T), intent(in) :: numvectors + type(SwigClassWrapper) :: fresult type(SwigClassWrapper) :: farg1 type(SwigArrayWrapper) :: farg2 @@ -6458,7 +6619,9 @@ function swigf_TpetraMultiVector_getData(self, j) & use, intrinsic :: ISO_C_BINDING real(C_DOUBLE), dimension(:), pointer :: swig_result class(TpetraMultiVector), intent(in) :: self + integer(C_SIZE_T), intent(in) :: j + type(SwigArrayWrapper) :: fresult type(SwigClassWrapper) :: farg1 integer(C_SIZE_T) :: farg2 @@ -6474,7 +6637,9 @@ function swigf_TpetraMultiVector_getDataNonConst(self, j) & use, intrinsic :: ISO_C_BINDING real(C_DOUBLE), dimension(:), pointer :: swig_result class(TpetraMultiVector), intent(inout) :: self + integer(C_SIZE_T), intent(in) :: j + type(SwigArrayWrapper) :: fresult type(SwigClassWrapper) :: farg1 integer(C_SIZE_T) :: farg2 @@ -6490,8 +6655,10 @@ function swigf_TpetraMultiVector_subCopy(self, cols) & use, intrinsic :: ISO_C_BINDING type(TpetraMultiVector) :: swig_result class(TpetraMultiVector), intent(in) :: self + integer(C_SIZE_T), dimension(:), target :: cols integer(C_SIZE_T), pointer :: farg2_view + type(SwigClassWrapper) :: fresult type(SwigClassWrapper) :: farg1 type(SwigArrayWrapper) :: farg2 @@ -6509,8 +6676,10 @@ function swigf_TpetraMultiVector_subView(self, cols) & use, intrinsic :: ISO_C_BINDING type(TpetraMultiVector) :: swig_result class(TpetraMultiVector), intent(in) :: self + integer(C_SIZE_T), dimension(:), target :: cols integer(C_SIZE_T), pointer :: farg2_view + type(SwigClassWrapper) :: fresult type(SwigClassWrapper) :: farg1 type(SwigArrayWrapper) :: farg2 @@ -6528,8 +6697,10 @@ function swigf_TpetraMultiVector_subViewNonConst(self, cols) & use, intrinsic :: ISO_C_BINDING type(TpetraMultiVector) :: swig_result class(TpetraMultiVector), intent(inout) :: self + integer(C_SIZE_T), dimension(:), target :: cols integer(C_SIZE_T), pointer :: farg2_view + type(SwigClassWrapper) :: fresult type(SwigClassWrapper) :: farg1 type(SwigArrayWrapper) :: farg2 @@ -6545,9 +6716,12 @@ function swigf_TpetraMultiVector_subViewNonConst(self, cols) & subroutine swigf_TpetraMultiVector_dot(self, a, dots) use, intrinsic :: ISO_C_BINDING class(TpetraMultiVector), intent(in) :: self + class(TpetraMultiVector), intent(in) :: a + real(C_DOUBLE), dimension(:), target :: dots real(C_DOUBLE), pointer :: farg3_view + type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 type(SwigArrayWrapper) :: farg3 @@ -6563,8 +6737,10 @@ subroutine swigf_TpetraMultiVector_dot(self, a, dots) subroutine swigf_TpetraMultiVector_norm1(self, norms) use, intrinsic :: ISO_C_BINDING class(TpetraMultiVector), intent(in) :: self + real(C_DOUBLE), dimension(:), target :: norms real(C_DOUBLE), pointer :: farg2_view + type(SwigClassWrapper) :: farg1 type(SwigArrayWrapper) :: farg2 @@ -6578,8 +6754,10 @@ subroutine swigf_TpetraMultiVector_norm1(self, norms) subroutine swigf_TpetraMultiVector_norm2(self, norms) use, intrinsic :: ISO_C_BINDING class(TpetraMultiVector), intent(in) :: self + real(C_DOUBLE), dimension(:), target :: norms real(C_DOUBLE), pointer :: farg2_view + type(SwigClassWrapper) :: farg1 type(SwigArrayWrapper) :: farg2 @@ -6593,8 +6771,10 @@ subroutine swigf_TpetraMultiVector_norm2(self, norms) subroutine swigf_TpetraMultiVector_normInf(self, norms) use, intrinsic :: ISO_C_BINDING class(TpetraMultiVector), intent(in) :: self + real(C_DOUBLE), dimension(:), target :: norms real(C_DOUBLE), pointer :: farg2_view + type(SwigClassWrapper) :: farg1 type(SwigArrayWrapper) :: farg2 @@ -6608,8 +6788,10 @@ subroutine swigf_TpetraMultiVector_normInf(self, norms) subroutine swigf_TpetraMultiVector_scale__SWIG_2(self, alpha) use, intrinsic :: ISO_C_BINDING class(TpetraMultiVector), intent(inout) :: self + real(C_DOUBLE), dimension(:), target :: alpha real(C_DOUBLE), pointer :: farg2_view + type(SwigClassWrapper) :: farg1 type(SwigArrayWrapper) :: farg2 @@ -6623,8 +6805,10 @@ subroutine swigf_TpetraMultiVector_scale__SWIG_2(self, alpha) subroutine swigf_TpetraMultiVector_meanValue(self, means) use, intrinsic :: ISO_C_BINDING class(TpetraMultiVector), intent(in) :: self + real(C_DOUBLE), dimension(:), target :: means real(C_DOUBLE), pointer :: farg2_view + type(SwigClassWrapper) :: farg1 type(SwigArrayWrapper) :: farg2 @@ -6638,9 +6822,11 @@ subroutine swigf_TpetraMultiVector_meanValue(self, means) subroutine swigf_TpetraMultiVector_get1dCopy(self, a, lda) use, intrinsic :: ISO_C_BINDING class(TpetraMultiVector), intent(in) :: self + real(C_DOUBLE), dimension(:), target :: a real(C_DOUBLE), pointer :: farg2_view integer(C_SIZE_T), intent(in) :: lda + type(SwigClassWrapper) :: farg1 type(SwigArrayWrapper) :: farg2 integer(C_SIZE_T) :: farg3 @@ -6658,6 +6844,7 @@ function swigf_TpetraMultiVector_get1dView(self) & use, intrinsic :: ISO_C_BINDING real(C_DOUBLE), dimension(:), pointer :: swig_result class(TpetraMultiVector), intent(in) :: self + type(SwigArrayWrapper) :: fresult type(SwigClassWrapper) :: farg1 @@ -6671,6 +6858,7 @@ function swigf_TpetraMultiVector_get1dViewNonConst(self) & use, intrinsic :: ISO_C_BINDING real(C_DOUBLE), dimension(:), pointer :: swig_result class(TpetraMultiVector), intent(inout) :: self + type(SwigArrayWrapper) :: fresult type(SwigClassWrapper) :: farg1 @@ -6682,9 +6870,13 @@ function swigf_TpetraMultiVector_get1dViewNonConst(self) & subroutine swigf_TpetraMultiVector_doImport__SWIG_0(self, source, importer, cm) use, intrinsic :: ISO_C_BINDING class(TpetraMultiVector), intent(inout) :: self + class(TpetraMultiVector), intent(in) :: source + class(TpetraImport), intent(in) :: importer -integer(kind(TpetraCombineMode)), intent(in) :: cm + +integer(TpetraCombineMode), intent(in) :: cm + type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 type(SwigClassWrapper) :: farg3 @@ -6700,9 +6892,13 @@ subroutine swigf_TpetraMultiVector_doImport__SWIG_0(self, source, importer, cm) subroutine swigf_TpetraMultiVector_doImport__SWIG_1(self, source, exporter, cm) use, intrinsic :: ISO_C_BINDING class(TpetraMultiVector), intent(inout) :: self + class(TpetraMultiVector), intent(in) :: source + class(TpetraExport), intent(in) :: exporter -integer(kind(TpetraCombineMode)), intent(in) :: cm + +integer(TpetraCombineMode), intent(in) :: cm + type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 type(SwigClassWrapper) :: farg3 @@ -6718,9 +6914,13 @@ subroutine swigf_TpetraMultiVector_doImport__SWIG_1(self, source, exporter, cm) subroutine swigf_TpetraMultiVector_doExport__SWIG_0(self, source, exporter, cm) use, intrinsic :: ISO_C_BINDING class(TpetraMultiVector), intent(inout) :: self + class(TpetraMultiVector), intent(in) :: source + class(TpetraExport), intent(in) :: exporter -integer(kind(TpetraCombineMode)), intent(in) :: cm + +integer(TpetraCombineMode), intent(in) :: cm + type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 type(SwigClassWrapper) :: farg3 @@ -6736,9 +6936,13 @@ subroutine swigf_TpetraMultiVector_doExport__SWIG_0(self, source, exporter, cm) subroutine swigf_TpetraMultiVector_doExport__SWIG_1(self, source, importer, cm) use, intrinsic :: ISO_C_BINDING class(TpetraMultiVector), intent(inout) :: self + class(TpetraMultiVector), intent(in) :: source + class(TpetraImport), intent(in) :: importer -integer(kind(TpetraCombineMode)), intent(in) :: cm + +integer(TpetraCombineMode), intent(in) :: cm + type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 type(SwigClassWrapper) :: farg3 @@ -6756,6 +6960,7 @@ function swigf_TpetraMultiVector_getMap(self) & use, intrinsic :: ISO_C_BINDING type(TpetraMap) :: swig_result class(TpetraMultiVector), intent(in) :: self + type(SwigClassWrapper) :: fresult type(SwigClassWrapper) :: farg1 @@ -6773,13 +6978,14 @@ subroutine swigf_assignment_TpetraMultiVector(self, other) subroutine delete_TpetraOperator(self) use, intrinsic :: ISO_C_BINDING class(TpetraOperator), intent(inout) :: self + type(SwigClassWrapper) :: farg1 farg1 = self%swigdata if (self%swigdata%mem == SWIG_OWN) then call swigc_delete_TpetraOperator(farg1) end if -self%swigdata%ptr = C_NULL_PTR +self%swigdata%cptr = C_NULL_PTR self%swigdata%mem = SWIG_NULL end subroutine @@ -6794,6 +7000,7 @@ function swigf_ForTpetraOperator_fhandle(self) & use, intrinsic :: ISO_C_BINDING type(C_PTR) :: swig_result class(ForTpetraOperator), intent(in) :: self + type(C_PTR) :: fresult type(SwigClassWrapper) :: farg1 @@ -6805,7 +7012,9 @@ function swigf_ForTpetraOperator_fhandle(self) & subroutine swigf_ForTpetraOperator_init(self, fh) use, intrinsic :: ISO_C_BINDING class(ForTpetraOperator), intent(inout) :: self + type(C_PTR) :: fh + type(SwigClassWrapper) :: farg1 type(C_PTR) :: farg2 @@ -6818,6 +7027,7 @@ function new_ForTpetraOperator() & result(self) use, intrinsic :: ISO_C_BINDING type(ForTpetraOperator) :: self + type(SwigClassWrapper) :: fresult fresult = swigc_new_ForTpetraOperator() @@ -6829,6 +7039,7 @@ function swigf_ForTpetraOperator_getDomainMap(self) & use, intrinsic :: ISO_C_BINDING type(TpetraMap) :: swig_result class(ForTpetraOperator), intent(in) :: self + type(SwigClassWrapper) :: fresult type(SwigClassWrapper) :: farg1 @@ -6842,6 +7053,7 @@ function swigf_ForTpetraOperator_getRangeMap(self) & use, intrinsic :: ISO_C_BINDING type(TpetraMap) :: swig_result class(ForTpetraOperator), intent(in) :: self + type(SwigClassWrapper) :: fresult type(SwigClassWrapper) :: farg1 @@ -6853,11 +7065,15 @@ function swigf_ForTpetraOperator_getRangeMap(self) & subroutine swigf_ForTpetraOperator_apply(self, x, y, mode, alpha, beta) use, intrinsic :: ISO_C_BINDING class(ForTpetraOperator), intent(in) :: self + class(TpetraMultiVector), intent(in) :: x + class(TpetraMultiVector), intent(inout) :: y -integer(kind(TeuchosETransp)), intent(in) :: mode + +integer(SWIGTYPE_Teuchos__ETransp), intent(in) :: mode real(C_DOUBLE), intent(in) :: alpha real(C_DOUBLE), intent(in) :: beta + type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 type(SwigClassWrapper) :: farg3 @@ -6877,6 +7093,7 @@ subroutine swigf_ForTpetraOperator_apply(self, x, y, mode, alpha, beta) subroutine delete_ForTpetraOperator(self) use, intrinsic :: ISO_C_BINDING class(ForTpetraOperator), intent(inout) :: self + type(SwigClassWrapper) :: farg1 @@ -6888,7 +7105,7 @@ subroutine delete_ForTpetraOperator(self) if (self%swigdata%mem == SWIG_OWN) then call swigc_delete_ForTpetraOperator(farg1) end if -self%swigdata%ptr = C_NULL_PTR +self%swigdata%cptr = C_NULL_PTR self%swigdata%mem = SWIG_NULL ! Release the allocated handle @@ -7012,7 +7229,9 @@ subroutine init_ForTpetraOperator(self) subroutine RowInfo_localRow_set(self, localrow) use, intrinsic :: ISO_C_BINDING class(RowInfo), intent(inout) :: self + integer(C_SIZE_T), intent(in) :: localrow + type(SwigClassWrapper) :: farg1 integer(C_SIZE_T) :: farg2 @@ -7026,6 +7245,7 @@ function RowInfo_localRow_get(self) & use, intrinsic :: ISO_C_BINDING integer(C_SIZE_T) :: swig_result class(RowInfo), intent(inout) :: self + integer(C_SIZE_T) :: fresult type(SwigClassWrapper) :: farg1 @@ -7037,7 +7257,9 @@ function RowInfo_localRow_get(self) & subroutine RowInfo_allocSize_set(self, allocsize) use, intrinsic :: ISO_C_BINDING class(RowInfo), intent(inout) :: self + integer(C_SIZE_T), intent(in) :: allocsize + type(SwigClassWrapper) :: farg1 integer(C_SIZE_T) :: farg2 @@ -7051,6 +7273,7 @@ function RowInfo_allocSize_get(self) & use, intrinsic :: ISO_C_BINDING integer(C_SIZE_T) :: swig_result class(RowInfo), intent(inout) :: self + integer(C_SIZE_T) :: fresult type(SwigClassWrapper) :: farg1 @@ -7062,7 +7285,9 @@ function RowInfo_allocSize_get(self) & subroutine RowInfo_numEntries_set(self, numentries) use, intrinsic :: ISO_C_BINDING class(RowInfo), intent(inout) :: self + integer(C_SIZE_T), intent(in) :: numentries + type(SwigClassWrapper) :: farg1 integer(C_SIZE_T) :: farg2 @@ -7076,6 +7301,7 @@ function RowInfo_numEntries_get(self) & use, intrinsic :: ISO_C_BINDING integer(C_SIZE_T) :: swig_result class(RowInfo), intent(inout) :: self + integer(C_SIZE_T) :: fresult type(SwigClassWrapper) :: farg1 @@ -7087,7 +7313,9 @@ function RowInfo_numEntries_get(self) & subroutine RowInfo_offset1D_set(self, offset1d) use, intrinsic :: ISO_C_BINDING class(RowInfo), intent(inout) :: self + integer(C_SIZE_T), intent(in) :: offset1d + type(SwigClassWrapper) :: farg1 integer(C_SIZE_T) :: farg2 @@ -7101,6 +7329,7 @@ function RowInfo_offset1D_get(self) & use, intrinsic :: ISO_C_BINDING integer(C_SIZE_T) :: swig_result class(RowInfo), intent(inout) :: self + integer(C_SIZE_T) :: fresult type(SwigClassWrapper) :: farg1 @@ -7113,6 +7342,7 @@ function new_RowInfo() & result(self) use, intrinsic :: ISO_C_BINDING type(RowInfo) :: self + type(SwigClassWrapper) :: fresult fresult = swigc_new_RowInfo() @@ -7122,13 +7352,14 @@ function new_RowInfo() & subroutine delete_RowInfo(self) use, intrinsic :: ISO_C_BINDING class(RowInfo), intent(inout) :: self + type(SwigClassWrapper) :: farg1 farg1 = self%swigdata if (self%swigdata%mem == SWIG_OWN) then call swigc_delete_RowInfo(farg1) end if -self%swigdata%ptr = C_NULL_PTR +self%swigdata%cptr = C_NULL_PTR self%swigdata%mem = SWIG_NULL end subroutine @@ -7143,9 +7374,11 @@ function new_TpetraCrsGraph__SWIG_0(rowmap, maxnumentriesperrow, pftype, params) use, intrinsic :: ISO_C_BINDING type(TpetraCrsGraph) :: self class(TpetraMap), intent(in) :: rowmap + integer(C_SIZE_T), intent(in) :: maxnumentriesperrow -integer(kind(TpetraProfileType)), intent(in) :: pftype +integer(TpetraProfileType), intent(in) :: pftype class(ParameterList), intent(in) :: params + type(SwigClassWrapper) :: fresult type(SwigClassWrapper) :: farg1 integer(C_SIZE_T) :: farg2 @@ -7165,8 +7398,10 @@ function new_TpetraCrsGraph__SWIG_1(rowmap, maxnumentriesperrow, pftype) & use, intrinsic :: ISO_C_BINDING type(TpetraCrsGraph) :: self class(TpetraMap), intent(in) :: rowmap + integer(C_SIZE_T), intent(in) :: maxnumentriesperrow -integer(kind(TpetraProfileType)), intent(in) :: pftype +integer(TpetraProfileType), intent(in) :: pftype + type(SwigClassWrapper) :: fresult type(SwigClassWrapper) :: farg1 integer(C_SIZE_T) :: farg2 @@ -7184,7 +7419,9 @@ function new_TpetraCrsGraph__SWIG_2(rowmap, maxnumentriesperrow) & use, intrinsic :: ISO_C_BINDING type(TpetraCrsGraph) :: self class(TpetraMap), intent(in) :: rowmap + integer(C_SIZE_T), intent(in) :: maxnumentriesperrow + type(SwigClassWrapper) :: fresult type(SwigClassWrapper) :: farg1 integer(C_SIZE_T) :: farg2 @@ -7200,10 +7437,13 @@ function new_TpetraCrsGraph__SWIG_3(rowmap, colmap, maxnumentriesperrow, pftype, use, intrinsic :: ISO_C_BINDING type(TpetraCrsGraph) :: self class(TpetraMap), intent(in) :: rowmap + class(TpetraMap), intent(in) :: colmap + integer(C_SIZE_T), intent(in) :: maxnumentriesperrow -integer(kind(TpetraProfileType)), intent(in) :: pftype +integer(TpetraProfileType), intent(in) :: pftype class(ParameterList), intent(in) :: params + type(SwigClassWrapper) :: fresult type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 @@ -7225,9 +7465,12 @@ function new_TpetraCrsGraph__SWIG_4(rowmap, colmap, maxnumentriesperrow, pftype) use, intrinsic :: ISO_C_BINDING type(TpetraCrsGraph) :: self class(TpetraMap), intent(in) :: rowmap + class(TpetraMap), intent(in) :: colmap + integer(C_SIZE_T), intent(in) :: maxnumentriesperrow -integer(kind(TpetraProfileType)), intent(in) :: pftype +integer(TpetraProfileType), intent(in) :: pftype + type(SwigClassWrapper) :: fresult type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 @@ -7247,8 +7490,11 @@ function new_TpetraCrsGraph__SWIG_5(rowmap, colmap, maxnumentriesperrow) & use, intrinsic :: ISO_C_BINDING type(TpetraCrsGraph) :: self class(TpetraMap), intent(in) :: rowmap + class(TpetraMap), intent(in) :: colmap + integer(C_SIZE_T), intent(in) :: maxnumentriesperrow + type(SwigClassWrapper) :: fresult type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 @@ -7264,22 +7510,25 @@ function new_TpetraCrsGraph__SWIG_5(rowmap, colmap, maxnumentriesperrow) & subroutine delete_TpetraCrsGraph(self) use, intrinsic :: ISO_C_BINDING class(TpetraCrsGraph), intent(inout) :: self + type(SwigClassWrapper) :: farg1 farg1 = self%swigdata if (self%swigdata%mem == SWIG_OWN) then call swigc_delete_TpetraCrsGraph(farg1) end if -self%swigdata%ptr = C_NULL_PTR +self%swigdata%cptr = C_NULL_PTR self%swigdata%mem = SWIG_NULL end subroutine subroutine swigf_TpetraCrsGraph_swap(self, graph) use, intrinsic :: ISO_C_BINDING class(TpetraCrsGraph), intent(inout) :: self + class(TpetraCrsGraph), intent(inout) :: graph -type(SwigClassWrapper) :: farg1 -type(SwigClassWrapper) :: farg2 + +type(SwigClassWrapper) :: farg1 +type(SwigClassWrapper) :: farg2 farg1 = self%swigdata farg2 = graph%swigdata @@ -7291,10 +7540,12 @@ function swigf_TpetraCrsGraph_isIdenticalTo(self, graph) & use, intrinsic :: ISO_C_BINDING logical(C_BOOL) :: swig_result class(TpetraCrsGraph), intent(in) :: self + class(TpetraCrsGraph), intent(in) :: graph -logical(C_BOOL) :: fresult -type(SwigClassWrapper) :: farg1 -type(SwigClassWrapper) :: farg2 + +logical(C_BOOL) :: fresult +type(SwigClassWrapper) :: farg1 +type(SwigClassWrapper) :: farg2 farg1 = self%swigdata farg2 = graph%swigdata @@ -7305,7 +7556,9 @@ function swigf_TpetraCrsGraph_isIdenticalTo(self, graph) & subroutine swigf_TpetraCrsGraph_setParameterList(self, params) use, intrinsic :: ISO_C_BINDING class(TpetraCrsGraph), intent(inout) :: self + class(ParameterList), intent(in) :: params + type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 @@ -7319,6 +7572,7 @@ function swigf_TpetraCrsGraph_getValidParameters(self) & use, intrinsic :: ISO_C_BINDING type(ParameterList) :: swig_result class(TpetraCrsGraph), intent(in) :: self + type(SwigClassWrapper) :: fresult type(SwigClassWrapper) :: farg1 @@ -7330,9 +7584,11 @@ function swigf_TpetraCrsGraph_getValidParameters(self) & subroutine swigf_TpetraCrsGraph_insertGlobalIndices__SWIG_0(self, globalrow, nument, inds) use, intrinsic :: ISO_C_BINDING class(TpetraCrsGraph), intent(inout) :: self + integer(C_LONG_LONG), intent(in) :: globalrow integer(C_INT), intent(in) :: nument -integer(C_LONG_LONG), target, intent(inout) :: inds +integer(C_LONG_LONG), dimension(*), target, intent(in) :: inds + type(SwigClassWrapper) :: farg1 integer(C_LONG_LONG) :: farg2 integer(C_INT) :: farg3 @@ -7341,14 +7597,16 @@ subroutine swigf_TpetraCrsGraph_insertGlobalIndices__SWIG_0(self, globalrow, num farg1 = self%swigdata farg2 = globalrow farg3 = nument -farg4 = c_loc(inds) +farg4 = c_loc(inds(1)) call swigc_TpetraCrsGraph_insertGlobalIndices__SWIG_0(farg1, farg2, farg3, farg4) end subroutine subroutine swigf_TpetraCrsGraph_removeLocalIndices(self, localrow) use, intrinsic :: ISO_C_BINDING class(TpetraCrsGraph), intent(inout) :: self + integer(C_INT), intent(in) :: localrow + type(SwigClassWrapper) :: farg1 integer(C_INT) :: farg2 @@ -7360,6 +7618,7 @@ subroutine swigf_TpetraCrsGraph_removeLocalIndices(self, localrow) subroutine swigf_TpetraCrsGraph_globalAssemble(self) use, intrinsic :: ISO_C_BINDING class(TpetraCrsGraph), intent(inout) :: self + type(SwigClassWrapper) :: farg1 farg1 = self%swigdata @@ -7369,7 +7628,9 @@ subroutine swigf_TpetraCrsGraph_globalAssemble(self) subroutine swigf_TpetraCrsGraph_resumeFill__SWIG_0(self, params) use, intrinsic :: ISO_C_BINDING class(TpetraCrsGraph), intent(inout) :: self + class(ParameterList), intent(in) :: params + type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 @@ -7381,6 +7642,7 @@ subroutine swigf_TpetraCrsGraph_resumeFill__SWIG_0(self, params) subroutine swigf_TpetraCrsGraph_resumeFill__SWIG_1(self) use, intrinsic :: ISO_C_BINDING class(TpetraCrsGraph), intent(inout) :: self + type(SwigClassWrapper) :: farg1 farg1 = self%swigdata @@ -7390,9 +7652,13 @@ subroutine swigf_TpetraCrsGraph_resumeFill__SWIG_1(self) subroutine swigf_TpetraCrsGraph_fillComplete__SWIG_0(self, domainmap, rangemap, params) use, intrinsic :: ISO_C_BINDING class(TpetraCrsGraph), intent(inout) :: self + class(TpetraMap), intent(in) :: domainmap + class(TpetraMap), intent(in) :: rangemap + class(ParameterList), intent(in) :: params + type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 type(SwigClassWrapper) :: farg3 @@ -7408,8 +7674,11 @@ subroutine swigf_TpetraCrsGraph_fillComplete__SWIG_0(self, domainmap, rangemap, subroutine swigf_TpetraCrsGraph_fillComplete__SWIG_1(self, domainmap, rangemap) use, intrinsic :: ISO_C_BINDING class(TpetraCrsGraph), intent(inout) :: self + class(TpetraMap), intent(in) :: domainmap + class(TpetraMap), intent(in) :: rangemap + type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 type(SwigClassWrapper) :: farg3 @@ -7423,7 +7692,9 @@ subroutine swigf_TpetraCrsGraph_fillComplete__SWIG_1(self, domainmap, rangemap) subroutine swigf_TpetraCrsGraph_fillComplete__SWIG_2(self, params) use, intrinsic :: ISO_C_BINDING class(TpetraCrsGraph), intent(inout) :: self + class(ParameterList), intent(in) :: params + type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 @@ -7435,6 +7706,7 @@ subroutine swigf_TpetraCrsGraph_fillComplete__SWIG_2(self, params) subroutine swigf_TpetraCrsGraph_fillComplete__SWIG_3(self) use, intrinsic :: ISO_C_BINDING class(TpetraCrsGraph), intent(inout) :: self + type(SwigClassWrapper) :: farg1 farg1 = self%swigdata @@ -7444,11 +7716,17 @@ subroutine swigf_TpetraCrsGraph_fillComplete__SWIG_3(self) subroutine swigf_TpetraCrsGraph_expertStaticFillComplete__SWIG_0(self, domainmap, rangemap, importer, exporter, params) use, intrinsic :: ISO_C_BINDING class(TpetraCrsGraph), intent(inout) :: self + class(TpetraMap), intent(in) :: domainmap + class(TpetraMap), intent(in) :: rangemap + class(TpetraImport), intent(in) :: importer + class(TpetraExport), intent(in) :: exporter + class(ParameterList), intent(in) :: params + type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 type(SwigClassWrapper) :: farg3 @@ -7468,10 +7746,15 @@ subroutine swigf_TpetraCrsGraph_expertStaticFillComplete__SWIG_0(self, domainmap subroutine swigf_TpetraCrsGraph_expertStaticFillComplete__SWIG_1(self, domainmap, rangemap, importer, exporter) use, intrinsic :: ISO_C_BINDING class(TpetraCrsGraph), intent(inout) :: self + class(TpetraMap), intent(in) :: domainmap + class(TpetraMap), intent(in) :: rangemap + class(TpetraImport), intent(in) :: importer + class(TpetraExport), intent(in) :: exporter + type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 type(SwigClassWrapper) :: farg3 @@ -7489,9 +7772,13 @@ subroutine swigf_TpetraCrsGraph_expertStaticFillComplete__SWIG_1(self, domainmap subroutine swigf_TpetraCrsGraph_expertStaticFillComplete__SWIG_2(self, domainmap, rangemap, importer) use, intrinsic :: ISO_C_BINDING class(TpetraCrsGraph), intent(inout) :: self + class(TpetraMap), intent(in) :: domainmap + class(TpetraMap), intent(in) :: rangemap + class(TpetraImport), intent(in) :: importer + type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 type(SwigClassWrapper) :: farg3 @@ -7507,8 +7794,11 @@ subroutine swigf_TpetraCrsGraph_expertStaticFillComplete__SWIG_2(self, domainmap subroutine swigf_TpetraCrsGraph_expertStaticFillComplete__SWIG_3(self, domainmap, rangemap) use, intrinsic :: ISO_C_BINDING class(TpetraCrsGraph), intent(inout) :: self + class(TpetraMap), intent(in) :: domainmap + class(TpetraMap), intent(in) :: rangemap + type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 type(SwigClassWrapper) :: farg3 @@ -7524,6 +7814,7 @@ function swigf_TpetraCrsGraph_getComm(self) & use, intrinsic :: ISO_C_BINDING type(TeuchosComm) :: swig_result class(TpetraCrsGraph), intent(in) :: self + type(SwigClassWrapper) :: fresult type(SwigClassWrapper) :: farg1 @@ -7537,6 +7828,7 @@ function swigf_TpetraCrsGraph_getRowMap(self) & use, intrinsic :: ISO_C_BINDING type(TpetraMap) :: swig_result class(TpetraCrsGraph), intent(in) :: self + type(SwigClassWrapper) :: fresult type(SwigClassWrapper) :: farg1 @@ -7550,6 +7842,7 @@ function swigf_TpetraCrsGraph_getColMap(self) & use, intrinsic :: ISO_C_BINDING type(TpetraMap) :: swig_result class(TpetraCrsGraph), intent(in) :: self + type(SwigClassWrapper) :: fresult type(SwigClassWrapper) :: farg1 @@ -7563,6 +7856,7 @@ function swigf_TpetraCrsGraph_getDomainMap(self) & use, intrinsic :: ISO_C_BINDING type(TpetraMap) :: swig_result class(TpetraCrsGraph), intent(in) :: self + type(SwigClassWrapper) :: fresult type(SwigClassWrapper) :: farg1 @@ -7576,6 +7870,7 @@ function swigf_TpetraCrsGraph_getRangeMap(self) & use, intrinsic :: ISO_C_BINDING type(TpetraMap) :: swig_result class(TpetraCrsGraph), intent(in) :: self + type(SwigClassWrapper) :: fresult type(SwigClassWrapper) :: farg1 @@ -7589,6 +7884,7 @@ function swigf_TpetraCrsGraph_getImporter(self) & use, intrinsic :: ISO_C_BINDING type(TpetraImport) :: swig_result class(TpetraCrsGraph), intent(in) :: self + type(SwigClassWrapper) :: fresult type(SwigClassWrapper) :: farg1 @@ -7602,6 +7898,7 @@ function swigf_TpetraCrsGraph_getExporter(self) & use, intrinsic :: ISO_C_BINDING type(TpetraExport) :: swig_result class(TpetraCrsGraph), intent(in) :: self + type(SwigClassWrapper) :: fresult type(SwigClassWrapper) :: farg1 @@ -7615,6 +7912,7 @@ function swigf_TpetraCrsGraph_getGlobalNumRows(self) & use, intrinsic :: ISO_C_BINDING integer(C_LONG) :: swig_result class(TpetraCrsGraph), intent(in) :: self + integer(C_LONG) :: fresult type(SwigClassWrapper) :: farg1 @@ -7628,6 +7926,7 @@ function swigf_TpetraCrsGraph_getGlobalNumCols(self) & use, intrinsic :: ISO_C_BINDING integer(C_LONG) :: swig_result class(TpetraCrsGraph), intent(in) :: self + integer(C_LONG) :: fresult type(SwigClassWrapper) :: farg1 @@ -7641,6 +7940,7 @@ function swigf_TpetraCrsGraph_getNodeNumRows(self) & use, intrinsic :: ISO_C_BINDING integer(C_SIZE_T) :: swig_result class(TpetraCrsGraph), intent(in) :: self + integer(C_SIZE_T) :: fresult type(SwigClassWrapper) :: farg1 @@ -7654,6 +7954,7 @@ function swigf_TpetraCrsGraph_getNodeNumCols(self) & use, intrinsic :: ISO_C_BINDING integer(C_SIZE_T) :: swig_result class(TpetraCrsGraph), intent(in) :: self + integer(C_SIZE_T) :: fresult type(SwigClassWrapper) :: farg1 @@ -7667,6 +7968,7 @@ function swigf_TpetraCrsGraph_getGlobalNumEntries(self) & use, intrinsic :: ISO_C_BINDING integer(C_LONG) :: swig_result class(TpetraCrsGraph), intent(in) :: self + integer(C_LONG) :: fresult type(SwigClassWrapper) :: farg1 @@ -7680,6 +7982,7 @@ function swigf_TpetraCrsGraph_getNodeNumEntries(self) & use, intrinsic :: ISO_C_BINDING integer(C_SIZE_T) :: swig_result class(TpetraCrsGraph), intent(in) :: self + integer(C_SIZE_T) :: fresult type(SwigClassWrapper) :: farg1 @@ -7693,7 +7996,9 @@ function swigf_TpetraCrsGraph_getNumEntriesInGlobalRow(self, globalrow) & use, intrinsic :: ISO_C_BINDING integer(C_SIZE_T) :: swig_result class(TpetraCrsGraph), intent(in) :: self + integer(C_LONG_LONG), intent(in) :: globalrow + integer(C_SIZE_T) :: fresult type(SwigClassWrapper) :: farg1 integer(C_LONG_LONG) :: farg2 @@ -7709,7 +8014,9 @@ function swigf_TpetraCrsGraph_getNumEntriesInLocalRow(self, localrow) & use, intrinsic :: ISO_C_BINDING integer(C_SIZE_T) :: swig_result class(TpetraCrsGraph), intent(in) :: self + integer(C_INT), intent(in) :: localrow + integer(C_SIZE_T) :: fresult type(SwigClassWrapper) :: farg1 integer(C_INT) :: farg2 @@ -7725,6 +8032,7 @@ function swigf_TpetraCrsGraph_getNodeAllocationSize(self) & use, intrinsic :: ISO_C_BINDING integer(C_SIZE_T) :: swig_result class(TpetraCrsGraph), intent(in) :: self + integer(C_SIZE_T) :: fresult type(SwigClassWrapper) :: farg1 @@ -7738,7 +8046,9 @@ function swigf_TpetraCrsGraph_getNumAllocatedEntriesInGlobalRow(self, globalrow) use, intrinsic :: ISO_C_BINDING integer(C_SIZE_T) :: swig_result class(TpetraCrsGraph), intent(in) :: self + integer(C_LONG_LONG), intent(in) :: globalrow + integer(C_SIZE_T) :: fresult type(SwigClassWrapper) :: farg1 integer(C_LONG_LONG) :: farg2 @@ -7754,7 +8064,9 @@ function swigf_TpetraCrsGraph_getNumAllocatedEntriesInLocalRow(self, localrow) & use, intrinsic :: ISO_C_BINDING integer(C_SIZE_T) :: swig_result class(TpetraCrsGraph), intent(in) :: self + integer(C_INT), intent(in) :: localrow + integer(C_SIZE_T) :: fresult type(SwigClassWrapper) :: farg1 integer(C_INT) :: farg2 @@ -7770,6 +8082,7 @@ function swigf_TpetraCrsGraph_getGlobalNumDiags(self) & use, intrinsic :: ISO_C_BINDING integer(C_LONG) :: swig_result class(TpetraCrsGraph), intent(in) :: self + integer(C_LONG) :: fresult type(SwigClassWrapper) :: farg1 @@ -7783,8 +8096,9 @@ function swigf_TpetraCrsGraph_getGlobalNumDiagsImpl(self) & use, intrinsic :: ISO_C_BINDING integer(C_LONG) :: swig_result class(TpetraCrsGraph), intent(in) :: self -integer(C_LONG) :: fresult -type(SwigClassWrapper) :: farg1 + +integer(C_LONG) :: fresult +type(SwigClassWrapper) :: farg1 farg1 = self%swigdata fresult = swigc_TpetraCrsGraph_getGlobalNumDiagsImpl(farg1) @@ -7796,6 +8110,7 @@ function swigf_TpetraCrsGraph_getNodeNumDiags(self) & use, intrinsic :: ISO_C_BINDING integer(C_SIZE_T) :: swig_result class(TpetraCrsGraph), intent(in) :: self + integer(C_SIZE_T) :: fresult type(SwigClassWrapper) :: farg1 @@ -7809,8 +8124,9 @@ function swigf_TpetraCrsGraph_getNodeNumDiagsImpl(self) & use, intrinsic :: ISO_C_BINDING integer(C_SIZE_T) :: swig_result class(TpetraCrsGraph), intent(in) :: self -integer(C_SIZE_T) :: fresult -type(SwigClassWrapper) :: farg1 + +integer(C_SIZE_T) :: fresult +type(SwigClassWrapper) :: farg1 farg1 = self%swigdata fresult = swigc_TpetraCrsGraph_getNodeNumDiagsImpl(farg1) @@ -7822,6 +8138,7 @@ function swigf_TpetraCrsGraph_getGlobalMaxNumRowEntries(self) & use, intrinsic :: ISO_C_BINDING integer(C_SIZE_T) :: swig_result class(TpetraCrsGraph), intent(in) :: self + integer(C_SIZE_T) :: fresult type(SwigClassWrapper) :: farg1 @@ -7835,6 +8152,7 @@ function swigf_TpetraCrsGraph_getNodeMaxNumRowEntries(self) & use, intrinsic :: ISO_C_BINDING integer(C_SIZE_T) :: swig_result class(TpetraCrsGraph), intent(in) :: self + integer(C_SIZE_T) :: fresult type(SwigClassWrapper) :: farg1 @@ -7848,6 +8166,7 @@ function swigf_TpetraCrsGraph_hasColMap(self) & use, intrinsic :: ISO_C_BINDING logical(C_BOOL) :: swig_result class(TpetraCrsGraph), intent(in) :: self + logical(C_BOOL) :: fresult type(SwigClassWrapper) :: farg1 @@ -7861,8 +8180,9 @@ function swigf_TpetraCrsGraph_isLowerTriangularImpl(self) & use, intrinsic :: ISO_C_BINDING logical(C_BOOL) :: swig_result class(TpetraCrsGraph), intent(in) :: self -logical(C_BOOL) :: fresult -type(SwigClassWrapper) :: farg1 + +logical(C_BOOL) :: fresult +type(SwigClassWrapper) :: farg1 farg1 = self%swigdata fresult = swigc_TpetraCrsGraph_isLowerTriangularImpl(farg1) @@ -7874,6 +8194,7 @@ function swigf_TpetraCrsGraph_isLowerTriangular(self) & use, intrinsic :: ISO_C_BINDING logical(C_BOOL) :: swig_result class(TpetraCrsGraph), intent(in) :: self + logical(C_BOOL) :: fresult type(SwigClassWrapper) :: farg1 @@ -7887,8 +8208,9 @@ function swigf_TpetraCrsGraph_isUpperTriangularImpl(self) & use, intrinsic :: ISO_C_BINDING logical(C_BOOL) :: swig_result class(TpetraCrsGraph), intent(in) :: self -logical(C_BOOL) :: fresult -type(SwigClassWrapper) :: farg1 + +logical(C_BOOL) :: fresult +type(SwigClassWrapper) :: farg1 farg1 = self%swigdata fresult = swigc_TpetraCrsGraph_isUpperTriangularImpl(farg1) @@ -7900,6 +8222,7 @@ function swigf_TpetraCrsGraph_isUpperTriangular(self) & use, intrinsic :: ISO_C_BINDING logical(C_BOOL) :: swig_result class(TpetraCrsGraph), intent(in) :: self + logical(C_BOOL) :: fresult type(SwigClassWrapper) :: farg1 @@ -7913,6 +8236,7 @@ function swigf_TpetraCrsGraph_isLocallyIndexed(self) & use, intrinsic :: ISO_C_BINDING logical(C_BOOL) :: swig_result class(TpetraCrsGraph), intent(in) :: self + logical(C_BOOL) :: fresult type(SwigClassWrapper) :: farg1 @@ -7926,6 +8250,7 @@ function swigf_TpetraCrsGraph_isGloballyIndexed(self) & use, intrinsic :: ISO_C_BINDING logical(C_BOOL) :: swig_result class(TpetraCrsGraph), intent(in) :: self + logical(C_BOOL) :: fresult type(SwigClassWrapper) :: farg1 @@ -7939,6 +8264,7 @@ function swigf_TpetraCrsGraph_isFillComplete(self) & use, intrinsic :: ISO_C_BINDING logical(C_BOOL) :: swig_result class(TpetraCrsGraph), intent(in) :: self + logical(C_BOOL) :: fresult type(SwigClassWrapper) :: farg1 @@ -7952,6 +8278,7 @@ function swigf_TpetraCrsGraph_isFillActive(self) & use, intrinsic :: ISO_C_BINDING logical(C_BOOL) :: swig_result class(TpetraCrsGraph), intent(in) :: self + logical(C_BOOL) :: fresult type(SwigClassWrapper) :: farg1 @@ -7965,6 +8292,7 @@ function swigf_TpetraCrsGraph_isSorted(self) & use, intrinsic :: ISO_C_BINDING logical(C_BOOL) :: swig_result class(TpetraCrsGraph), intent(in) :: self + logical(C_BOOL) :: fresult type(SwigClassWrapper) :: farg1 @@ -7978,6 +8306,7 @@ function swigf_TpetraCrsGraph_isStorageOptimized(self) & use, intrinsic :: ISO_C_BINDING logical(C_BOOL) :: swig_result class(TpetraCrsGraph), intent(in) :: self + logical(C_BOOL) :: fresult type(SwigClassWrapper) :: farg1 @@ -7989,8 +8318,9 @@ function swigf_TpetraCrsGraph_isStorageOptimized(self) & function swigf_TpetraCrsGraph_getProfileType(self) & result(swig_result) use, intrinsic :: ISO_C_BINDING -integer(kind(TpetraProfileType)) :: swig_result +integer(TpetraProfileType) :: swig_result class(TpetraCrsGraph), intent(in) :: self + integer(C_INT) :: fresult type(SwigClassWrapper) :: farg1 @@ -8004,6 +8334,7 @@ function swigf_TpetraCrsGraph_supportsRowViews(self) & use, intrinsic :: ISO_C_BINDING logical(C_BOOL) :: swig_result class(TpetraCrsGraph), intent(in) :: self + logical(C_BOOL) :: fresult type(SwigClassWrapper) :: farg1 @@ -8017,6 +8348,7 @@ function swigf_TpetraCrsGraph_description(self) & use, intrinsic :: ISO_C_BINDING character(kind=C_CHAR, len=:), allocatable :: swig_result class(TpetraCrsGraph), intent(in) :: self + type(SwigArrayWrapper) :: fresult type(SwigClassWrapper) :: farg1 @@ -8029,7 +8361,9 @@ function swigf_TpetraCrsGraph_description(self) & subroutine swigf_TpetraCrsGraph_replaceColMap(self, newcolmap) use, intrinsic :: ISO_C_BINDING class(TpetraCrsGraph), intent(inout) :: self + class(TpetraMap), intent(in) :: newcolmap + type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 @@ -8041,9 +8375,13 @@ subroutine swigf_TpetraCrsGraph_replaceColMap(self, newcolmap) subroutine swigf_TpetraCrsGraph_reindexColumns__SWIG_0(self, newcolmap, newimport, sortindicesineachrow) use, intrinsic :: ISO_C_BINDING class(TpetraCrsGraph), intent(inout) :: self + class(TpetraMap), intent(in) :: newcolmap + class(TpetraImport), intent(in) :: newimport + logical(C_BOOL), intent(in) :: sortindicesineachrow + type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 type(SwigClassWrapper) :: farg3 @@ -8059,8 +8397,11 @@ subroutine swigf_TpetraCrsGraph_reindexColumns__SWIG_0(self, newcolmap, newimpor subroutine swigf_TpetraCrsGraph_reindexColumns__SWIG_1(self, newcolmap, newimport) use, intrinsic :: ISO_C_BINDING class(TpetraCrsGraph), intent(inout) :: self + class(TpetraMap), intent(in) :: newcolmap + class(TpetraImport), intent(in) :: newimport + type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 type(SwigClassWrapper) :: farg3 @@ -8074,7 +8415,9 @@ subroutine swigf_TpetraCrsGraph_reindexColumns__SWIG_1(self, newcolmap, newimpor subroutine swigf_TpetraCrsGraph_reindexColumns__SWIG_2(self, newcolmap) use, intrinsic :: ISO_C_BINDING class(TpetraCrsGraph), intent(inout) :: self + class(TpetraMap), intent(in) :: newcolmap + type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 @@ -8086,8 +8429,11 @@ subroutine swigf_TpetraCrsGraph_reindexColumns__SWIG_2(self, newcolmap) subroutine swigf_TpetraCrsGraph_replaceDomainMapAndImporter(self, newdomainmap, newimporter) use, intrinsic :: ISO_C_BINDING class(TpetraCrsGraph), intent(inout) :: self + class(TpetraMap), intent(in) :: newdomainmap + class(TpetraImport), intent(in) :: newimporter + type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 type(SwigClassWrapper) :: farg3 @@ -8101,7 +8447,9 @@ subroutine swigf_TpetraCrsGraph_replaceDomainMapAndImporter(self, newdomainmap, subroutine swigf_TpetraCrsGraph_removeEmptyProcessesInPlace(self, newmap) use, intrinsic :: ISO_C_BINDING class(TpetraCrsGraph), intent(inout) :: self + class(TpetraMap), intent(in) :: newmap + type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 @@ -8113,17 +8461,23 @@ subroutine swigf_TpetraCrsGraph_removeEmptyProcessesInPlace(self, newmap) subroutine swigf_TpetraCrsGraph_importAndFillComplete__SWIG_0(self, destgraph, importer, domainmap, rangemap, params) use, intrinsic :: ISO_C_BINDING class(TpetraCrsGraph), intent(in) :: self + class(TpetraCrsGraph), intent(inout) :: destgraph + class(TpetraImport), intent(in) :: importer + class(TpetraMap), intent(in) :: domainmap + class(TpetraMap), intent(in) :: rangemap + class(ParameterList), intent(in) :: params -type(SwigClassWrapper) :: farg1 -type(SwigClassWrapper) :: farg2 -type(SwigClassWrapper) :: farg3 -type(SwigClassWrapper) :: farg4 -type(SwigClassWrapper) :: farg5 -type(SwigClassWrapper) :: farg6 + +type(SwigClassWrapper) :: farg1 +type(SwigClassWrapper) :: farg2 +type(SwigClassWrapper) :: farg3 +type(SwigClassWrapper) :: farg4 +type(SwigClassWrapper) :: farg5 +type(SwigClassWrapper) :: farg6 farg1 = self%swigdata farg2 = destgraph%swigdata @@ -8137,15 +8491,20 @@ subroutine swigf_TpetraCrsGraph_importAndFillComplete__SWIG_0(self, destgraph, i subroutine swigf_TpetraCrsGraph_importAndFillComplete__SWIG_1(self, destgraph, importer, domainmap, rangemap) use, intrinsic :: ISO_C_BINDING class(TpetraCrsGraph), intent(in) :: self + class(TpetraCrsGraph), intent(inout) :: destgraph + class(TpetraImport), intent(in) :: importer + class(TpetraMap), intent(in) :: domainmap + class(TpetraMap), intent(in) :: rangemap -type(SwigClassWrapper) :: farg1 -type(SwigClassWrapper) :: farg2 -type(SwigClassWrapper) :: farg3 -type(SwigClassWrapper) :: farg4 -type(SwigClassWrapper) :: farg5 + +type(SwigClassWrapper) :: farg1 +type(SwigClassWrapper) :: farg2 +type(SwigClassWrapper) :: farg3 +type(SwigClassWrapper) :: farg4 +type(SwigClassWrapper) :: farg5 farg1 = self%swigdata farg2 = destgraph%swigdata @@ -8159,19 +8518,26 @@ subroutine swigf_TpetraCrsGraph_importAndFillComplete__SWIG_2(self, destgraph, r rangemap, params) use, intrinsic :: ISO_C_BINDING class(TpetraCrsGraph), intent(in) :: self + class(TpetraCrsGraph), intent(inout) :: destgraph + class(TpetraImport), intent(in) :: rowimporter + class(TpetraImport), intent(in) :: domainimporter + class(TpetraMap), intent(in) :: domainmap + class(TpetraMap), intent(in) :: rangemap + class(ParameterList), intent(in) :: params -type(SwigClassWrapper) :: farg1 -type(SwigClassWrapper) :: farg2 -type(SwigClassWrapper) :: farg3 -type(SwigClassWrapper) :: farg4 -type(SwigClassWrapper) :: farg5 -type(SwigClassWrapper) :: farg6 -type(SwigClassWrapper) :: farg7 + +type(SwigClassWrapper) :: farg1 +type(SwigClassWrapper) :: farg2 +type(SwigClassWrapper) :: farg3 +type(SwigClassWrapper) :: farg4 +type(SwigClassWrapper) :: farg5 +type(SwigClassWrapper) :: farg6 +type(SwigClassWrapper) :: farg7 farg1 = self%swigdata farg2 = destgraph%swigdata @@ -8186,17 +8552,23 @@ subroutine swigf_TpetraCrsGraph_importAndFillComplete__SWIG_2(self, destgraph, r subroutine swigf_TpetraCrsGraph_exportAndFillComplete__SWIG_0(self, destgraph, exporter, domainmap, rangemap, params) use, intrinsic :: ISO_C_BINDING class(TpetraCrsGraph), intent(in) :: self + class(TpetraCrsGraph), intent(inout) :: destgraph + class(TpetraExport), intent(in) :: exporter + class(TpetraMap), intent(in) :: domainmap + class(TpetraMap), intent(in) :: rangemap + class(ParameterList), intent(in) :: params -type(SwigClassWrapper) :: farg1 -type(SwigClassWrapper) :: farg2 -type(SwigClassWrapper) :: farg3 -type(SwigClassWrapper) :: farg4 -type(SwigClassWrapper) :: farg5 -type(SwigClassWrapper) :: farg6 + +type(SwigClassWrapper) :: farg1 +type(SwigClassWrapper) :: farg2 +type(SwigClassWrapper) :: farg3 +type(SwigClassWrapper) :: farg4 +type(SwigClassWrapper) :: farg5 +type(SwigClassWrapper) :: farg6 farg1 = self%swigdata farg2 = destgraph%swigdata @@ -8210,15 +8582,20 @@ subroutine swigf_TpetraCrsGraph_exportAndFillComplete__SWIG_0(self, destgraph, e subroutine swigf_TpetraCrsGraph_exportAndFillComplete__SWIG_1(self, destgraph, exporter, domainmap, rangemap) use, intrinsic :: ISO_C_BINDING class(TpetraCrsGraph), intent(in) :: self + class(TpetraCrsGraph), intent(inout) :: destgraph + class(TpetraExport), intent(in) :: exporter + class(TpetraMap), intent(in) :: domainmap + class(TpetraMap), intent(in) :: rangemap -type(SwigClassWrapper) :: farg1 -type(SwigClassWrapper) :: farg2 -type(SwigClassWrapper) :: farg3 -type(SwigClassWrapper) :: farg4 -type(SwigClassWrapper) :: farg5 + +type(SwigClassWrapper) :: farg1 +type(SwigClassWrapper) :: farg2 +type(SwigClassWrapper) :: farg3 +type(SwigClassWrapper) :: farg4 +type(SwigClassWrapper) :: farg5 farg1 = self%swigdata farg2 = destgraph%swigdata @@ -8231,13 +8608,17 @@ subroutine swigf_TpetraCrsGraph_exportAndFillComplete__SWIG_1(self, destgraph, e subroutine swigf_TpetraCrsGraph_exportAndFillComplete__SWIG_2(self, destgraph, exporter, domainmap) use, intrinsic :: ISO_C_BINDING class(TpetraCrsGraph), intent(in) :: self + class(TpetraCrsGraph), intent(inout) :: destgraph + class(TpetraExport), intent(in) :: exporter + class(TpetraMap), intent(in) :: domainmap -type(SwigClassWrapper) :: farg1 -type(SwigClassWrapper) :: farg2 -type(SwigClassWrapper) :: farg3 -type(SwigClassWrapper) :: farg4 + +type(SwigClassWrapper) :: farg1 +type(SwigClassWrapper) :: farg2 +type(SwigClassWrapper) :: farg3 +type(SwigClassWrapper) :: farg4 farg1 = self%swigdata farg2 = destgraph%swigdata @@ -8249,11 +8630,14 @@ subroutine swigf_TpetraCrsGraph_exportAndFillComplete__SWIG_2(self, destgraph, e subroutine swigf_TpetraCrsGraph_exportAndFillComplete__SWIG_3(self, destgraph, exporter) use, intrinsic :: ISO_C_BINDING class(TpetraCrsGraph), intent(in) :: self + class(TpetraCrsGraph), intent(inout) :: destgraph + class(TpetraExport), intent(in) :: exporter -type(SwigClassWrapper) :: farg1 -type(SwigClassWrapper) :: farg2 -type(SwigClassWrapper) :: farg3 + +type(SwigClassWrapper) :: farg1 +type(SwigClassWrapper) :: farg2 +type(SwigClassWrapper) :: farg3 farg1 = self%swigdata farg2 = destgraph%swigdata @@ -8265,19 +8649,26 @@ subroutine swigf_TpetraCrsGraph_exportAndFillComplete__SWIG_4(self, destgraph, r rangemap, params) use, intrinsic :: ISO_C_BINDING class(TpetraCrsGraph), intent(in) :: self + class(TpetraCrsGraph), intent(inout) :: destgraph + class(TpetraExport), intent(in) :: rowexporter + class(TpetraExport), intent(in) :: domainexporter + class(TpetraMap), intent(in) :: domainmap + class(TpetraMap), intent(in) :: rangemap + class(ParameterList), intent(in) :: params -type(SwigClassWrapper) :: farg1 -type(SwigClassWrapper) :: farg2 -type(SwigClassWrapper) :: farg3 -type(SwigClassWrapper) :: farg4 -type(SwigClassWrapper) :: farg5 -type(SwigClassWrapper) :: farg6 -type(SwigClassWrapper) :: farg7 + +type(SwigClassWrapper) :: farg1 +type(SwigClassWrapper) :: farg2 +type(SwigClassWrapper) :: farg3 +type(SwigClassWrapper) :: farg4 +type(SwigClassWrapper) :: farg5 +type(SwigClassWrapper) :: farg6 +type(SwigClassWrapper) :: farg7 farg1 = self%swigdata farg2 = destgraph%swigdata @@ -8294,6 +8685,7 @@ function swigf_TpetraCrsGraph_haveGlobalConstants(self) & use, intrinsic :: ISO_C_BINDING logical(C_BOOL) :: swig_result class(TpetraCrsGraph), intent(in) :: self + logical(C_BOOL) :: fresult type(SwigClassWrapper) :: farg1 @@ -8305,9 +8697,11 @@ function swigf_TpetraCrsGraph_haveGlobalConstants(self) & subroutine swigf_TpetraCrsGraph_computeGlobalConstants(self, computelocaltriangularconstants) use, intrinsic :: ISO_C_BINDING class(TpetraCrsGraph), intent(inout) :: self + logical(C_BOOL), intent(in) :: computelocaltriangularconstants + type(SwigClassWrapper) :: farg1 -logical(C_BOOL) :: farg2 +logical(C_BOOL) :: farg2 farg1 = self%swigdata farg2 = computelocaltriangularconstants @@ -8319,10 +8713,12 @@ function new_TpetraCrsGraph__SWIG_6(rowmap, numentperrow, pftype, params) & use, intrinsic :: ISO_C_BINDING type(TpetraCrsGraph) :: self class(TpetraMap), intent(in) :: rowmap + integer(C_SIZE_T), dimension(:), target :: numentperrow integer(C_SIZE_T), pointer :: farg2_view -integer(kind(TpetraProfileType)), intent(in) :: pftype +integer(TpetraProfileType), intent(in) :: pftype class(ParameterList), intent(in) :: params + type(SwigClassWrapper) :: fresult type(SwigClassWrapper) :: farg1 type(SwigArrayWrapper) :: farg2 @@ -8344,9 +8740,11 @@ function new_TpetraCrsGraph__SWIG_7(rowmap, numentperrow, pftype) & use, intrinsic :: ISO_C_BINDING type(TpetraCrsGraph) :: self class(TpetraMap), intent(in) :: rowmap + integer(C_SIZE_T), dimension(:), target :: numentperrow integer(C_SIZE_T), pointer :: farg2_view -integer(kind(TpetraProfileType)), intent(in) :: pftype +integer(TpetraProfileType), intent(in) :: pftype + type(SwigClassWrapper) :: fresult type(SwigClassWrapper) :: farg1 type(SwigArrayWrapper) :: farg2 @@ -8366,8 +8764,10 @@ function new_TpetraCrsGraph__SWIG_8(rowmap, numentperrow) & use, intrinsic :: ISO_C_BINDING type(TpetraCrsGraph) :: self class(TpetraMap), intent(in) :: rowmap + integer(C_SIZE_T), dimension(:), target :: numentperrow integer(C_SIZE_T), pointer :: farg2_view + type(SwigClassWrapper) :: fresult type(SwigClassWrapper) :: farg1 type(SwigArrayWrapper) :: farg2 @@ -8385,11 +8785,14 @@ function new_TpetraCrsGraph__SWIG_9(rowmap, colmap, numentperrow, pftype, params use, intrinsic :: ISO_C_BINDING type(TpetraCrsGraph) :: self class(TpetraMap), intent(in) :: rowmap + class(TpetraMap), intent(in) :: colmap + integer(C_SIZE_T), dimension(:), target :: numentperrow integer(C_SIZE_T), pointer :: farg3_view -integer(kind(TpetraProfileType)), intent(in) :: pftype +integer(TpetraProfileType), intent(in) :: pftype class(ParameterList), intent(in) :: params + type(SwigClassWrapper) :: fresult type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 @@ -8413,10 +8816,13 @@ function new_TpetraCrsGraph__SWIG_10(rowmap, colmap, numentperrow, pftype) & use, intrinsic :: ISO_C_BINDING type(TpetraCrsGraph) :: self class(TpetraMap), intent(in) :: rowmap + class(TpetraMap), intent(in) :: colmap + integer(C_SIZE_T), dimension(:), target :: numentperrow integer(C_SIZE_T), pointer :: farg3_view -integer(kind(TpetraProfileType)), intent(in) :: pftype +integer(TpetraProfileType), intent(in) :: pftype + type(SwigClassWrapper) :: fresult type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 @@ -8438,9 +8844,12 @@ function new_TpetraCrsGraph__SWIG_11(rowmap, colmap, numentperrow) & use, intrinsic :: ISO_C_BINDING type(TpetraCrsGraph) :: self class(TpetraMap), intent(in) :: rowmap + class(TpetraMap), intent(in) :: colmap + integer(C_SIZE_T), dimension(:), target :: numentperrow integer(C_SIZE_T), pointer :: farg3_view + type(SwigClassWrapper) :: fresult type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 @@ -8460,12 +8869,15 @@ function new_TpetraCrsGraph__SWIG_12(rowmap, colmap, rowpointers, columnindices, use, intrinsic :: ISO_C_BINDING type(TpetraCrsGraph) :: self class(TpetraMap), intent(in) :: rowmap + class(TpetraMap), intent(in) :: colmap + integer(C_SIZE_T), dimension(:), target :: rowpointers integer(C_SIZE_T), pointer :: farg3_view integer(C_INT), dimension(:), target :: columnindices integer(C_INT), pointer :: farg4_view class(ParameterList), intent(in) :: params + type(SwigClassWrapper) :: fresult type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 @@ -8491,11 +8903,14 @@ function new_TpetraCrsGraph__SWIG_13(rowmap, colmap, rowpointers, columnindices) use, intrinsic :: ISO_C_BINDING type(TpetraCrsGraph) :: self class(TpetraMap), intent(in) :: rowmap + class(TpetraMap), intent(in) :: colmap + integer(C_SIZE_T), dimension(:), target :: rowpointers integer(C_SIZE_T), pointer :: farg3_view integer(C_INT), dimension(:), target :: columnindices integer(C_INT), pointer :: farg4_view + type(SwigClassWrapper) :: fresult type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 @@ -8517,9 +8932,11 @@ function new_TpetraCrsGraph__SWIG_13(rowmap, colmap, rowpointers, columnindices) subroutine swigf_TpetraCrsGraph_insertGlobalIndices__SWIG_1(self, globalrow, indices) use, intrinsic :: ISO_C_BINDING class(TpetraCrsGraph), intent(inout) :: self + integer(C_LONG_LONG), intent(in) :: globalrow integer(C_LONG_LONG), dimension(:), target :: indices integer(C_LONG_LONG), pointer :: farg3_view + type(SwigClassWrapper) :: farg1 integer(C_LONG_LONG) :: farg2 type(SwigArrayWrapper) :: farg3 @@ -8535,9 +8952,11 @@ subroutine swigf_TpetraCrsGraph_insertGlobalIndices__SWIG_1(self, globalrow, ind subroutine swigf_TpetraCrsGraph_insertLocalIndices(self, localrow, indices) use, intrinsic :: ISO_C_BINDING class(TpetraCrsGraph), intent(inout) :: self + integer(C_INT), intent(in) :: localrow integer(C_INT), dimension(:), target :: indices integer(C_INT), pointer :: farg3_view + type(SwigClassWrapper) :: farg1 integer(C_INT) :: farg2 type(SwigArrayWrapper) :: farg3 @@ -8553,10 +8972,12 @@ subroutine swigf_TpetraCrsGraph_insertLocalIndices(self, localrow, indices) subroutine swigf_TpetraCrsGraph_getGlobalRowCopy(self, globalrow, indices, numindices) use, intrinsic :: ISO_C_BINDING class(TpetraCrsGraph), intent(in) :: self + integer(C_LONG_LONG), intent(in) :: globalrow integer(C_LONG_LONG), dimension(:), target :: indices integer(C_LONG_LONG), pointer :: farg3_view integer(C_SIZE_T), target, intent(inout) :: numindices + type(SwigClassWrapper) :: farg1 integer(C_LONG_LONG) :: farg2 type(SwigArrayWrapper) :: farg3 @@ -8574,10 +8995,12 @@ subroutine swigf_TpetraCrsGraph_getGlobalRowCopy(self, globalrow, indices, numin subroutine swigf_TpetraCrsGraph_getLocalRowCopy(self, localrow, indices, numindices) use, intrinsic :: ISO_C_BINDING class(TpetraCrsGraph), intent(in) :: self + integer(C_INT), intent(in) :: localrow integer(C_INT), dimension(:), target :: indices integer(C_INT), pointer :: farg3_view integer(C_SIZE_T), target, intent(inout) :: numindices + type(SwigClassWrapper) :: farg1 integer(C_INT) :: farg2 type(SwigArrayWrapper) :: farg3 @@ -8595,9 +9018,11 @@ subroutine swigf_TpetraCrsGraph_getLocalRowCopy(self, localrow, indices, numindi subroutine swigf_TpetraCrsGraph_getgblRowView(self, gblrow, lclcolinds) use, intrinsic :: ISO_C_BINDING class(TpetraCrsGraph), intent(in) :: self + integer(C_LONG_LONG), intent(in) :: gblrow integer(C_LONG_LONG), dimension(:), target :: lclcolinds integer(C_LONG_LONG), pointer :: farg3_view + type(SwigClassWrapper) :: farg1 integer(C_LONG_LONG) :: farg2 type(SwigArrayWrapper) :: farg3 @@ -8613,12 +9038,14 @@ subroutine swigf_TpetraCrsGraph_getgblRowView(self, gblrow, lclcolinds) subroutine swigf_TpetraCrsGraph_setAllIndices(self, rowpointers, columnindices, val) use, intrinsic :: ISO_C_BINDING class(TpetraCrsGraph), intent(inout) :: self + integer(C_SIZE_T), dimension(:), target :: rowpointers integer(C_SIZE_T), pointer :: farg2_view integer(C_INT), dimension(:), target :: columnindices integer(C_INT), pointer :: farg3_view real(C_DOUBLE), dimension(:), target :: val real(C_DOUBLE), pointer :: farg4_view + type(SwigClassWrapper) :: farg1 type(SwigArrayWrapper) :: farg2 type(SwigArrayWrapper) :: farg3 @@ -8640,8 +9067,10 @@ subroutine swigf_TpetraCrsGraph_setAllIndices(self, rowpointers, columnindices, subroutine swigf_TpetraCrsGraph_getNodeRowPtrs(self, rowpointers) use, intrinsic :: ISO_C_BINDING class(TpetraCrsGraph), intent(in) :: self + integer(C_SIZE_T), dimension(:), target :: rowpointers integer(C_SIZE_T), pointer :: farg2_view + type(SwigClassWrapper) :: farg1 type(SwigArrayWrapper) :: farg2 @@ -8655,8 +9084,10 @@ subroutine swigf_TpetraCrsGraph_getNodeRowPtrs(self, rowpointers) subroutine swigf_TpetraCrsGraph_getNodePackedIndices(self, columnindices) use, intrinsic :: ISO_C_BINDING class(TpetraCrsGraph), intent(in) :: self + integer(C_SIZE_T), dimension(:), target :: columnindices integer(C_SIZE_T), pointer :: farg2_view + type(SwigClassWrapper) :: farg1 type(SwigArrayWrapper) :: farg2 @@ -8670,8 +9101,10 @@ subroutine swigf_TpetraCrsGraph_getNodePackedIndices(self, columnindices) subroutine swigf_TpetraCrsGraph_getLocalDiagOffsets(self, offsets) use, intrinsic :: ISO_C_BINDING class(TpetraCrsGraph), intent(in) :: self + integer(C_SIZE_T), dimension(:), target :: offsets integer(C_SIZE_T), pointer :: farg2_view + type(SwigClassWrapper) :: farg1 type(SwigArrayWrapper) :: farg2 @@ -8685,9 +9118,13 @@ subroutine swigf_TpetraCrsGraph_getLocalDiagOffsets(self, offsets) subroutine swigf_TpetraCrsGraph_doImport__SWIG_0(self, source, importer, cm) use, intrinsic :: ISO_C_BINDING class(TpetraCrsGraph), intent(inout) :: self + class(TpetraCrsGraph), intent(in) :: source + class(TpetraImport), intent(in) :: importer -integer(kind(TpetraCombineMode)), intent(in) :: cm + +integer(TpetraCombineMode), intent(in) :: cm + type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 type(SwigClassWrapper) :: farg3 @@ -8703,9 +9140,13 @@ subroutine swigf_TpetraCrsGraph_doImport__SWIG_0(self, source, importer, cm) subroutine swigf_TpetraCrsGraph_doImport__SWIG_1(self, source, exporter, cm) use, intrinsic :: ISO_C_BINDING class(TpetraCrsGraph), intent(inout) :: self + class(TpetraCrsGraph), intent(in) :: source + class(TpetraExport), intent(in) :: exporter -integer(kind(TpetraCombineMode)), intent(in) :: cm + +integer(TpetraCombineMode), intent(in) :: cm + type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 type(SwigClassWrapper) :: farg3 @@ -8721,9 +9162,13 @@ subroutine swigf_TpetraCrsGraph_doImport__SWIG_1(self, source, exporter, cm) subroutine swigf_TpetraCrsGraph_doExport__SWIG_0(self, source, exporter, cm) use, intrinsic :: ISO_C_BINDING class(TpetraCrsGraph), intent(inout) :: self + class(TpetraCrsGraph), intent(in) :: source + class(TpetraExport), intent(in) :: exporter -integer(kind(TpetraCombineMode)), intent(in) :: cm + +integer(TpetraCombineMode), intent(in) :: cm + type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 type(SwigClassWrapper) :: farg3 @@ -8739,9 +9184,13 @@ subroutine swigf_TpetraCrsGraph_doExport__SWIG_0(self, source, exporter, cm) subroutine swigf_TpetraCrsGraph_doExport__SWIG_1(self, source, importer, cm) use, intrinsic :: ISO_C_BINDING class(TpetraCrsGraph), intent(inout) :: self + class(TpetraCrsGraph), intent(in) :: source + class(TpetraImport), intent(in) :: importer -integer(kind(TpetraCombineMode)), intent(in) :: cm + +integer(TpetraCombineMode), intent(in) :: cm + type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 type(SwigClassWrapper) :: farg3 @@ -8765,9 +9214,11 @@ function new_TpetraCrsMatrix__SWIG_0(rowmap, maxnumentriesperrow, pftype, params use, intrinsic :: ISO_C_BINDING type(TpetraCrsMatrix) :: self class(TpetraMap), intent(in) :: rowmap + integer(C_SIZE_T), intent(in) :: maxnumentriesperrow -integer(kind(TpetraProfileType)), intent(in) :: pftype +integer(TpetraProfileType), intent(in) :: pftype class(ParameterList), intent(in) :: params + type(SwigClassWrapper) :: fresult type(SwigClassWrapper) :: farg1 integer(C_SIZE_T) :: farg2 @@ -8787,8 +9238,10 @@ function new_TpetraCrsMatrix__SWIG_1(rowmap, maxnumentriesperrow, pftype) & use, intrinsic :: ISO_C_BINDING type(TpetraCrsMatrix) :: self class(TpetraMap), intent(in) :: rowmap + integer(C_SIZE_T), intent(in) :: maxnumentriesperrow -integer(kind(TpetraProfileType)), intent(in) :: pftype +integer(TpetraProfileType), intent(in) :: pftype + type(SwigClassWrapper) :: fresult type(SwigClassWrapper) :: farg1 integer(C_SIZE_T) :: farg2 @@ -8806,7 +9259,9 @@ function new_TpetraCrsMatrix__SWIG_2(rowmap, maxnumentriesperrow) & use, intrinsic :: ISO_C_BINDING type(TpetraCrsMatrix) :: self class(TpetraMap), intent(in) :: rowmap + integer(C_SIZE_T), intent(in) :: maxnumentriesperrow + type(SwigClassWrapper) :: fresult type(SwigClassWrapper) :: farg1 integer(C_SIZE_T) :: farg2 @@ -8822,10 +9277,13 @@ function new_TpetraCrsMatrix__SWIG_3(rowmap, colmap, maxnumentriesperrow, pftype use, intrinsic :: ISO_C_BINDING type(TpetraCrsMatrix) :: self class(TpetraMap), intent(in) :: rowmap + class(TpetraMap), intent(in) :: colmap + integer(C_SIZE_T), intent(in) :: maxnumentriesperrow -integer(kind(TpetraProfileType)), intent(in) :: pftype +integer(TpetraProfileType), intent(in) :: pftype class(ParameterList), intent(in) :: params + type(SwigClassWrapper) :: fresult type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 @@ -8847,9 +9305,12 @@ function new_TpetraCrsMatrix__SWIG_4(rowmap, colmap, maxnumentriesperrow, pftype use, intrinsic :: ISO_C_BINDING type(TpetraCrsMatrix) :: self class(TpetraMap), intent(in) :: rowmap + class(TpetraMap), intent(in) :: colmap + integer(C_SIZE_T), intent(in) :: maxnumentriesperrow -integer(kind(TpetraProfileType)), intent(in) :: pftype +integer(TpetraProfileType), intent(in) :: pftype + type(SwigClassWrapper) :: fresult type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 @@ -8869,8 +9330,11 @@ function new_TpetraCrsMatrix__SWIG_5(rowmap, colmap, maxnumentriesperrow) & use, intrinsic :: ISO_C_BINDING type(TpetraCrsMatrix) :: self class(TpetraMap), intent(in) :: rowmap + class(TpetraMap), intent(in) :: colmap + integer(C_SIZE_T), intent(in) :: maxnumentriesperrow + type(SwigClassWrapper) :: fresult type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 @@ -8888,7 +9352,9 @@ function new_TpetraCrsMatrix__SWIG_6(graph, params) & use, intrinsic :: ISO_C_BINDING type(TpetraCrsMatrix) :: self class(TpetraCrsGraph), intent(in) :: graph + class(ParameterList), intent(in) :: params + type(SwigClassWrapper) :: fresult type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 @@ -8904,6 +9370,7 @@ function new_TpetraCrsMatrix__SWIG_7(graph) & use, intrinsic :: ISO_C_BINDING type(TpetraCrsMatrix) :: self class(TpetraCrsGraph), intent(in) :: graph + type(SwigClassWrapper) :: fresult type(SwigClassWrapper) :: farg1 @@ -8917,12 +9384,15 @@ function new_TpetraCrsMatrix__SWIG_8(graph, values, params) & use, intrinsic :: ISO_C_BINDING type(TpetraCrsMatrix) :: self class(TpetraCrsGraph), intent(in) :: graph -class(SwigUnknownClass), intent(in) :: values + +class(SWIGTYPE_KokkosSparse__CrsMatrixT_Tpetra__CrsMatrixT_doub1E12GN), intent(in) :: values + class(ParameterList), intent(in) :: params -type(SwigClassWrapper) :: fresult -type(SwigClassWrapper) :: farg1 -type(SwigClassWrapper) :: farg2 -type(SwigClassWrapper) :: farg3 + +type(SwigClassWrapper) :: fresult +type(SwigClassWrapper) :: farg1 +type(SwigClassWrapper) :: farg2 +type(SwigClassWrapper) :: farg3 farg1 = graph%swigdata farg2 = values%swigdata @@ -8936,10 +9406,12 @@ function new_TpetraCrsMatrix__SWIG_9(graph, values) & use, intrinsic :: ISO_C_BINDING type(TpetraCrsMatrix) :: self class(TpetraCrsGraph), intent(in) :: graph -class(SwigUnknownClass), intent(in) :: values -type(SwigClassWrapper) :: fresult -type(SwigClassWrapper) :: farg1 -type(SwigClassWrapper) :: farg2 + +class(SWIGTYPE_KokkosSparse__CrsMatrixT_Tpetra__CrsMatrixT_doub1E12GN), intent(in) :: values + +type(SwigClassWrapper) :: fresult +type(SwigClassWrapper) :: farg1 +type(SwigClassWrapper) :: farg2 farg1 = graph%swigdata farg2 = values%swigdata @@ -8950,20 +9422,23 @@ function new_TpetraCrsMatrix__SWIG_9(graph, values) & subroutine delete_TpetraCrsMatrix(self) use, intrinsic :: ISO_C_BINDING class(TpetraCrsMatrix), intent(inout) :: self + type(SwigClassWrapper) :: farg1 farg1 = self%swigdata if (self%swigdata%mem == SWIG_OWN) then call swigc_delete_TpetraCrsMatrix(farg1) end if -self%swigdata%ptr = C_NULL_PTR +self%swigdata%cptr = C_NULL_PTR self%swigdata%mem = SWIG_NULL end subroutine subroutine swigf_TpetraCrsMatrix_setAllToScalar(self, alpha) use, intrinsic :: ISO_C_BINDING class(TpetraCrsMatrix), intent(inout) :: self + real(C_DOUBLE), intent(in) :: alpha + type(SwigClassWrapper) :: farg1 real(C_DOUBLE) :: farg2 @@ -8975,7 +9450,9 @@ subroutine swigf_TpetraCrsMatrix_setAllToScalar(self, alpha) subroutine swigf_TpetraCrsMatrix_scale(self, alpha) use, intrinsic :: ISO_C_BINDING class(TpetraCrsMatrix), intent(inout) :: self + real(C_DOUBLE), intent(in) :: alpha + type(SwigClassWrapper) :: farg1 real(C_DOUBLE) :: farg2 @@ -8987,6 +9464,7 @@ subroutine swigf_TpetraCrsMatrix_scale(self, alpha) subroutine swigf_TpetraCrsMatrix_globalAssemble(self) use, intrinsic :: ISO_C_BINDING class(TpetraCrsMatrix), intent(inout) :: self + type(SwigClassWrapper) :: farg1 farg1 = self%swigdata @@ -8996,7 +9474,9 @@ subroutine swigf_TpetraCrsMatrix_globalAssemble(self) subroutine swigf_TpetraCrsMatrix_resumeFill__SWIG_0(self, params) use, intrinsic :: ISO_C_BINDING class(TpetraCrsMatrix), intent(inout) :: self + class(ParameterList), intent(in) :: params + type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 @@ -9008,6 +9488,7 @@ subroutine swigf_TpetraCrsMatrix_resumeFill__SWIG_0(self, params) subroutine swigf_TpetraCrsMatrix_resumeFill__SWIG_1(self) use, intrinsic :: ISO_C_BINDING class(TpetraCrsMatrix), intent(inout) :: self + type(SwigClassWrapper) :: farg1 farg1 = self%swigdata @@ -9017,9 +9498,13 @@ subroutine swigf_TpetraCrsMatrix_resumeFill__SWIG_1(self) subroutine swigf_TpetraCrsMatrix_fillComplete__SWIG_0(self, domainmap, rangemap, params) use, intrinsic :: ISO_C_BINDING class(TpetraCrsMatrix), intent(inout) :: self + class(TpetraMap), intent(in) :: domainmap + class(TpetraMap), intent(in) :: rangemap + class(ParameterList), intent(in) :: params + type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 type(SwigClassWrapper) :: farg3 @@ -9035,8 +9520,11 @@ subroutine swigf_TpetraCrsMatrix_fillComplete__SWIG_0(self, domainmap, rangemap, subroutine swigf_TpetraCrsMatrix_fillComplete__SWIG_1(self, domainmap, rangemap) use, intrinsic :: ISO_C_BINDING class(TpetraCrsMatrix), intent(inout) :: self + class(TpetraMap), intent(in) :: domainmap + class(TpetraMap), intent(in) :: rangemap + type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 type(SwigClassWrapper) :: farg3 @@ -9050,7 +9538,9 @@ subroutine swigf_TpetraCrsMatrix_fillComplete__SWIG_1(self, domainmap, rangemap) subroutine swigf_TpetraCrsMatrix_fillComplete__SWIG_2(self, params) use, intrinsic :: ISO_C_BINDING class(TpetraCrsMatrix), intent(inout) :: self + class(ParameterList), intent(in) :: params + type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 @@ -9062,6 +9552,7 @@ subroutine swigf_TpetraCrsMatrix_fillComplete__SWIG_2(self, params) subroutine swigf_TpetraCrsMatrix_fillComplete__SWIG_3(self) use, intrinsic :: ISO_C_BINDING class(TpetraCrsMatrix), intent(inout) :: self + type(SwigClassWrapper) :: farg1 farg1 = self%swigdata @@ -9071,11 +9562,17 @@ subroutine swigf_TpetraCrsMatrix_fillComplete__SWIG_3(self) subroutine swigf_TpetraCrsMatrix_expertStaticFillComplete__SWIG_0(self, domainmap, rangemap, importer, exporter, params) use, intrinsic :: ISO_C_BINDING class(TpetraCrsMatrix), intent(inout) :: self + class(TpetraMap), intent(in) :: domainmap + class(TpetraMap), intent(in) :: rangemap + class(TpetraImport), intent(in) :: importer + class(TpetraExport), intent(in) :: exporter + class(ParameterList), intent(in) :: params + type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 type(SwigClassWrapper) :: farg3 @@ -9095,10 +9592,15 @@ subroutine swigf_TpetraCrsMatrix_expertStaticFillComplete__SWIG_0(self, domainma subroutine swigf_TpetraCrsMatrix_expertStaticFillComplete__SWIG_1(self, domainmap, rangemap, importer, exporter) use, intrinsic :: ISO_C_BINDING class(TpetraCrsMatrix), intent(inout) :: self + class(TpetraMap), intent(in) :: domainmap + class(TpetraMap), intent(in) :: rangemap + class(TpetraImport), intent(in) :: importer + class(TpetraExport), intent(in) :: exporter + type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 type(SwigClassWrapper) :: farg3 @@ -9116,9 +9618,13 @@ subroutine swigf_TpetraCrsMatrix_expertStaticFillComplete__SWIG_1(self, domainma subroutine swigf_TpetraCrsMatrix_expertStaticFillComplete__SWIG_2(self, domainmap, rangemap, importer) use, intrinsic :: ISO_C_BINDING class(TpetraCrsMatrix), intent(inout) :: self + class(TpetraMap), intent(in) :: domainmap + class(TpetraMap), intent(in) :: rangemap + class(TpetraImport), intent(in) :: importer + type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 type(SwigClassWrapper) :: farg3 @@ -9134,8 +9640,11 @@ subroutine swigf_TpetraCrsMatrix_expertStaticFillComplete__SWIG_2(self, domainma subroutine swigf_TpetraCrsMatrix_expertStaticFillComplete__SWIG_3(self, domainmap, rangemap) use, intrinsic :: ISO_C_BINDING class(TpetraCrsMatrix), intent(inout) :: self + class(TpetraMap), intent(in) :: domainmap + class(TpetraMap), intent(in) :: rangemap + type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 type(SwigClassWrapper) :: farg3 @@ -9149,7 +9658,9 @@ subroutine swigf_TpetraCrsMatrix_expertStaticFillComplete__SWIG_3(self, domainma subroutine swigf_TpetraCrsMatrix_replaceColMap(self, newcolmap) use, intrinsic :: ISO_C_BINDING class(TpetraCrsMatrix), intent(inout) :: self + class(TpetraMap), intent(in) :: newcolmap + type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 @@ -9161,10 +9672,15 @@ subroutine swigf_TpetraCrsMatrix_replaceColMap(self, newcolmap) subroutine swigf_TpetraCrsMatrix_reindexColumns__SWIG_0(self, graph, newcolmap, newimport, sorteachrow) use, intrinsic :: ISO_C_BINDING class(TpetraCrsMatrix), intent(inout) :: self + class(TpetraCrsGraph), intent(inout) :: graph + class(TpetraMap), intent(in) :: newcolmap + class(TpetraImport), intent(in) :: newimport + logical(C_BOOL), intent(in) :: sorteachrow + type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 type(SwigClassWrapper) :: farg3 @@ -9182,9 +9698,13 @@ subroutine swigf_TpetraCrsMatrix_reindexColumns__SWIG_0(self, graph, newcolmap, subroutine swigf_TpetraCrsMatrix_reindexColumns__SWIG_1(self, graph, newcolmap, newimport) use, intrinsic :: ISO_C_BINDING class(TpetraCrsMatrix), intent(inout) :: self + class(TpetraCrsGraph), intent(inout) :: graph + class(TpetraMap), intent(in) :: newcolmap + class(TpetraImport), intent(in) :: newimport + type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 type(SwigClassWrapper) :: farg3 @@ -9200,8 +9720,11 @@ subroutine swigf_TpetraCrsMatrix_reindexColumns__SWIG_1(self, graph, newcolmap, subroutine swigf_TpetraCrsMatrix_reindexColumns__SWIG_2(self, graph, newcolmap) use, intrinsic :: ISO_C_BINDING class(TpetraCrsMatrix), intent(inout) :: self + class(TpetraCrsGraph), intent(inout) :: graph + class(TpetraMap), intent(in) :: newcolmap + type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 type(SwigClassWrapper) :: farg3 @@ -9215,8 +9738,11 @@ subroutine swigf_TpetraCrsMatrix_reindexColumns__SWIG_2(self, graph, newcolmap) subroutine swigf_TpetraCrsMatrix_replaceDomainMapAndImporter(self, newdomainmap, newimporter) use, intrinsic :: ISO_C_BINDING class(TpetraCrsMatrix), intent(inout) :: self + class(TpetraMap), intent(in) :: newdomainmap + class(TpetraImport), intent(inout) :: newimporter + type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 type(SwigClassWrapper) :: farg3 @@ -9230,7 +9756,9 @@ subroutine swigf_TpetraCrsMatrix_replaceDomainMapAndImporter(self, newdomainmap, subroutine swigf_TpetraCrsMatrix_removeEmptyProcessesInPlace(self, newmap) use, intrinsic :: ISO_C_BINDING class(TpetraCrsMatrix), intent(inout) :: self + class(TpetraMap), intent(in) :: newmap + type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 @@ -9244,6 +9772,7 @@ function swigf_TpetraCrsMatrix_getComm(self) & use, intrinsic :: ISO_C_BINDING type(TeuchosComm) :: swig_result class(TpetraCrsMatrix), intent(in) :: self + type(SwigClassWrapper) :: fresult type(SwigClassWrapper) :: farg1 @@ -9257,6 +9786,7 @@ function swigf_TpetraCrsMatrix_getRowMap(self) & use, intrinsic :: ISO_C_BINDING type(TpetraMap) :: swig_result class(TpetraCrsMatrix), intent(in) :: self + type(SwigClassWrapper) :: fresult type(SwigClassWrapper) :: farg1 @@ -9270,6 +9800,7 @@ function swigf_TpetraCrsMatrix_getColMap(self) & use, intrinsic :: ISO_C_BINDING type(TpetraMap) :: swig_result class(TpetraCrsMatrix), intent(in) :: self + type(SwigClassWrapper) :: fresult type(SwigClassWrapper) :: farg1 @@ -9283,6 +9814,7 @@ function swigf_TpetraCrsMatrix_getCrsGraph(self) & use, intrinsic :: ISO_C_BINDING type(TpetraCrsGraph) :: swig_result class(TpetraCrsMatrix), intent(in) :: self + type(SwigClassWrapper) :: fresult type(SwigClassWrapper) :: farg1 @@ -9296,6 +9828,7 @@ function swigf_TpetraCrsMatrix_getGlobalNumRows(self) & use, intrinsic :: ISO_C_BINDING integer(C_LONG) :: swig_result class(TpetraCrsMatrix), intent(in) :: self + integer(C_LONG) :: fresult type(SwigClassWrapper) :: farg1 @@ -9309,6 +9842,7 @@ function swigf_TpetraCrsMatrix_getGlobalNumCols(self) & use, intrinsic :: ISO_C_BINDING integer(C_LONG) :: swig_result class(TpetraCrsMatrix), intent(in) :: self + integer(C_LONG) :: fresult type(SwigClassWrapper) :: farg1 @@ -9322,6 +9856,7 @@ function swigf_TpetraCrsMatrix_getNodeNumRows(self) & use, intrinsic :: ISO_C_BINDING integer(C_SIZE_T) :: swig_result class(TpetraCrsMatrix), intent(in) :: self + integer(C_SIZE_T) :: fresult type(SwigClassWrapper) :: farg1 @@ -9335,6 +9870,7 @@ function swigf_TpetraCrsMatrix_getNodeNumCols(self) & use, intrinsic :: ISO_C_BINDING integer(C_SIZE_T) :: swig_result class(TpetraCrsMatrix), intent(in) :: self + integer(C_SIZE_T) :: fresult type(SwigClassWrapper) :: farg1 @@ -9348,6 +9884,7 @@ function swigf_TpetraCrsMatrix_getGlobalNumEntries(self) & use, intrinsic :: ISO_C_BINDING integer(C_LONG) :: swig_result class(TpetraCrsMatrix), intent(in) :: self + integer(C_LONG) :: fresult type(SwigClassWrapper) :: farg1 @@ -9361,6 +9898,7 @@ function swigf_TpetraCrsMatrix_getNodeNumEntries(self) & use, intrinsic :: ISO_C_BINDING integer(C_SIZE_T) :: swig_result class(TpetraCrsMatrix), intent(in) :: self + integer(C_SIZE_T) :: fresult type(SwigClassWrapper) :: farg1 @@ -9374,7 +9912,9 @@ function swigf_TpetraCrsMatrix_getNumEntriesInGlobalRow(self, globalrow) & use, intrinsic :: ISO_C_BINDING integer(C_SIZE_T) :: swig_result class(TpetraCrsMatrix), intent(in) :: self + integer(C_LONG_LONG), intent(in) :: globalrow + integer(C_SIZE_T) :: fresult type(SwigClassWrapper) :: farg1 integer(C_LONG_LONG) :: farg2 @@ -9390,7 +9930,9 @@ function swigf_TpetraCrsMatrix_getNumEntriesInLocalRow(self, localrow) & use, intrinsic :: ISO_C_BINDING integer(C_SIZE_T) :: swig_result class(TpetraCrsMatrix), intent(in) :: self + integer(C_INT), intent(in) :: localrow + integer(C_SIZE_T) :: fresult type(SwigClassWrapper) :: farg1 integer(C_INT) :: farg2 @@ -9406,8 +9948,9 @@ function swigf_TpetraCrsMatrix_getGlobalNumDiagsImpl(self) & use, intrinsic :: ISO_C_BINDING integer(C_LONG) :: swig_result class(TpetraCrsMatrix), intent(in) :: self -integer(C_LONG) :: fresult -type(SwigClassWrapper) :: farg1 + +integer(C_LONG) :: fresult +type(SwigClassWrapper) :: farg1 farg1 = self%swigdata fresult = swigc_TpetraCrsMatrix_getGlobalNumDiagsImpl(farg1) @@ -9419,6 +9962,7 @@ function swigf_TpetraCrsMatrix_getGlobalNumDiags(self) & use, intrinsic :: ISO_C_BINDING integer(C_LONG) :: swig_result class(TpetraCrsMatrix), intent(in) :: self + integer(C_LONG) :: fresult type(SwigClassWrapper) :: farg1 @@ -9432,8 +9976,9 @@ function swigf_TpetraCrsMatrix_getNodeNumDiagsImpl(self) & use, intrinsic :: ISO_C_BINDING integer(C_SIZE_T) :: swig_result class(TpetraCrsMatrix), intent(in) :: self -integer(C_SIZE_T) :: fresult -type(SwigClassWrapper) :: farg1 + +integer(C_SIZE_T) :: fresult +type(SwigClassWrapper) :: farg1 farg1 = self%swigdata fresult = swigc_TpetraCrsMatrix_getNodeNumDiagsImpl(farg1) @@ -9445,6 +9990,7 @@ function swigf_TpetraCrsMatrix_getNodeNumDiags(self) & use, intrinsic :: ISO_C_BINDING integer(C_SIZE_T) :: swig_result class(TpetraCrsMatrix), intent(in) :: self + integer(C_SIZE_T) :: fresult type(SwigClassWrapper) :: farg1 @@ -9458,6 +10004,7 @@ function swigf_TpetraCrsMatrix_getGlobalMaxNumRowEntries(self) & use, intrinsic :: ISO_C_BINDING integer(C_SIZE_T) :: swig_result class(TpetraCrsMatrix), intent(in) :: self + integer(C_SIZE_T) :: fresult type(SwigClassWrapper) :: farg1 @@ -9471,6 +10018,7 @@ function swigf_TpetraCrsMatrix_getNodeMaxNumRowEntries(self) & use, intrinsic :: ISO_C_BINDING integer(C_SIZE_T) :: swig_result class(TpetraCrsMatrix), intent(in) :: self + integer(C_SIZE_T) :: fresult type(SwigClassWrapper) :: farg1 @@ -9484,6 +10032,7 @@ function swigf_TpetraCrsMatrix_hasColMap(self) & use, intrinsic :: ISO_C_BINDING logical(C_BOOL) :: swig_result class(TpetraCrsMatrix), intent(in) :: self + logical(C_BOOL) :: fresult type(SwigClassWrapper) :: farg1 @@ -9497,8 +10046,9 @@ function swigf_TpetraCrsMatrix_isLowerTriangularImpl(self) & use, intrinsic :: ISO_C_BINDING logical(C_BOOL) :: swig_result class(TpetraCrsMatrix), intent(in) :: self -logical(C_BOOL) :: fresult -type(SwigClassWrapper) :: farg1 + +logical(C_BOOL) :: fresult +type(SwigClassWrapper) :: farg1 farg1 = self%swigdata fresult = swigc_TpetraCrsMatrix_isLowerTriangularImpl(farg1) @@ -9510,6 +10060,7 @@ function swigf_TpetraCrsMatrix_isLowerTriangular(self) & use, intrinsic :: ISO_C_BINDING logical(C_BOOL) :: swig_result class(TpetraCrsMatrix), intent(in) :: self + logical(C_BOOL) :: fresult type(SwigClassWrapper) :: farg1 @@ -9523,8 +10074,9 @@ function swigf_TpetraCrsMatrix_isUpperTriangularImpl(self) & use, intrinsic :: ISO_C_BINDING logical(C_BOOL) :: swig_result class(TpetraCrsMatrix), intent(in) :: self -logical(C_BOOL) :: fresult -type(SwigClassWrapper) :: farg1 + +logical(C_BOOL) :: fresult +type(SwigClassWrapper) :: farg1 farg1 = self%swigdata fresult = swigc_TpetraCrsMatrix_isUpperTriangularImpl(farg1) @@ -9536,6 +10088,7 @@ function swigf_TpetraCrsMatrix_isUpperTriangular(self) & use, intrinsic :: ISO_C_BINDING logical(C_BOOL) :: swig_result class(TpetraCrsMatrix), intent(in) :: self + logical(C_BOOL) :: fresult type(SwigClassWrapper) :: farg1 @@ -9549,6 +10102,7 @@ function swigf_TpetraCrsMatrix_isLocallyIndexed(self) & use, intrinsic :: ISO_C_BINDING logical(C_BOOL) :: swig_result class(TpetraCrsMatrix), intent(in) :: self + logical(C_BOOL) :: fresult type(SwigClassWrapper) :: farg1 @@ -9562,6 +10116,7 @@ function swigf_TpetraCrsMatrix_isGloballyIndexed(self) & use, intrinsic :: ISO_C_BINDING logical(C_BOOL) :: swig_result class(TpetraCrsMatrix), intent(in) :: self + logical(C_BOOL) :: fresult type(SwigClassWrapper) :: farg1 @@ -9575,6 +10130,7 @@ function swigf_TpetraCrsMatrix_isFillComplete(self) & use, intrinsic :: ISO_C_BINDING logical(C_BOOL) :: swig_result class(TpetraCrsMatrix), intent(in) :: self + logical(C_BOOL) :: fresult type(SwigClassWrapper) :: farg1 @@ -9588,6 +10144,7 @@ function swigf_TpetraCrsMatrix_isFillActive(self) & use, intrinsic :: ISO_C_BINDING logical(C_BOOL) :: swig_result class(TpetraCrsMatrix), intent(in) :: self + logical(C_BOOL) :: fresult type(SwigClassWrapper) :: farg1 @@ -9601,6 +10158,7 @@ function swigf_TpetraCrsMatrix_isStorageOptimized(self) & use, intrinsic :: ISO_C_BINDING logical(C_BOOL) :: swig_result class(TpetraCrsMatrix), intent(in) :: self + logical(C_BOOL) :: fresult type(SwigClassWrapper) :: farg1 @@ -9612,8 +10170,9 @@ function swigf_TpetraCrsMatrix_isStorageOptimized(self) & function swigf_TpetraCrsMatrix_getProfileType(self) & result(swig_result) use, intrinsic :: ISO_C_BINDING -integer(kind(TpetraProfileType)) :: swig_result +integer(TpetraProfileType) :: swig_result class(TpetraCrsMatrix), intent(in) :: self + integer(C_INT) :: fresult type(SwigClassWrapper) :: farg1 @@ -9627,6 +10186,7 @@ function swigf_TpetraCrsMatrix_isStaticGraph(self) & use, intrinsic :: ISO_C_BINDING logical(C_BOOL) :: swig_result class(TpetraCrsMatrix), intent(in) :: self + logical(C_BOOL) :: fresult type(SwigClassWrapper) :: farg1 @@ -9640,6 +10200,7 @@ function swigf_TpetraCrsMatrix_getFrobeniusNorm(self) & use, intrinsic :: ISO_C_BINDING real(C_DOUBLE) :: swig_result class(TpetraCrsMatrix), intent(in) :: self + real(C_DOUBLE) :: fresult type(SwigClassWrapper) :: farg1 @@ -9653,6 +10214,7 @@ function swigf_TpetraCrsMatrix_supportsRowViews(self) & use, intrinsic :: ISO_C_BINDING logical(C_BOOL) :: swig_result class(TpetraCrsMatrix), intent(in) :: self + logical(C_BOOL) :: fresult type(SwigClassWrapper) :: farg1 @@ -9664,11 +10226,15 @@ function swigf_TpetraCrsMatrix_supportsRowViews(self) & subroutine swigf_TpetraCrsMatrix_apply__SWIG_0(self, x, y, mode, alpha, beta) use, intrinsic :: ISO_C_BINDING class(TpetraCrsMatrix), intent(in) :: self + class(TpetraMultiVector), intent(in) :: x + class(TpetraMultiVector), intent(inout) :: y -integer(kind(TeuchosETransp)), intent(in) :: mode + +integer(SWIGTYPE_Teuchos__ETransp), intent(in) :: mode real(C_DOUBLE), intent(in) :: alpha real(C_DOUBLE), intent(in) :: beta + type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 type(SwigClassWrapper) :: farg3 @@ -9688,10 +10254,14 @@ subroutine swigf_TpetraCrsMatrix_apply__SWIG_0(self, x, y, mode, alpha, beta) subroutine swigf_TpetraCrsMatrix_apply__SWIG_1(self, x, y, mode, alpha) use, intrinsic :: ISO_C_BINDING class(TpetraCrsMatrix), intent(in) :: self + class(TpetraMultiVector), intent(in) :: x + class(TpetraMultiVector), intent(inout) :: y -integer(kind(TeuchosETransp)), intent(in) :: mode + +integer(SWIGTYPE_Teuchos__ETransp), intent(in) :: mode real(C_DOUBLE), intent(in) :: alpha + type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 type(SwigClassWrapper) :: farg3 @@ -9709,9 +10279,13 @@ subroutine swigf_TpetraCrsMatrix_apply__SWIG_1(self, x, y, mode, alpha) subroutine swigf_TpetraCrsMatrix_apply__SWIG_2(self, x, y, mode) use, intrinsic :: ISO_C_BINDING class(TpetraCrsMatrix), intent(in) :: self + class(TpetraMultiVector), intent(in) :: x + class(TpetraMultiVector), intent(inout) :: y -integer(kind(TeuchosETransp)), intent(in) :: mode + +integer(SWIGTYPE_Teuchos__ETransp), intent(in) :: mode + type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 type(SwigClassWrapper) :: farg3 @@ -9727,8 +10301,11 @@ subroutine swigf_TpetraCrsMatrix_apply__SWIG_2(self, x, y, mode) subroutine swigf_TpetraCrsMatrix_apply__SWIG_3(self, x, y) use, intrinsic :: ISO_C_BINDING class(TpetraCrsMatrix), intent(in) :: self + class(TpetraMultiVector), intent(in) :: x + class(TpetraMultiVector), intent(inout) :: y + type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 type(SwigClassWrapper) :: farg3 @@ -9744,6 +10321,7 @@ function swigf_TpetraCrsMatrix_hasTransposeApply(self) & use, intrinsic :: ISO_C_BINDING logical(C_BOOL) :: swig_result class(TpetraCrsMatrix), intent(in) :: self + logical(C_BOOL) :: fresult type(SwigClassWrapper) :: farg1 @@ -9757,6 +10335,7 @@ function swigf_TpetraCrsMatrix_getDomainMap(self) & use, intrinsic :: ISO_C_BINDING type(TpetraMap) :: swig_result class(TpetraCrsMatrix), intent(in) :: self + type(SwigClassWrapper) :: fresult type(SwigClassWrapper) :: farg1 @@ -9770,6 +10349,7 @@ function swigf_TpetraCrsMatrix_getRangeMap(self) & use, intrinsic :: ISO_C_BINDING type(TpetraMap) :: swig_result class(TpetraCrsMatrix), intent(in) :: self + type(SwigClassWrapper) :: fresult type(SwigClassWrapper) :: farg1 @@ -9781,12 +10361,17 @@ function swigf_TpetraCrsMatrix_getRangeMap(self) & subroutine swigf_TpetraCrsMatrix_gaussSeidel(self, b, x, d, dampingfactor, direction, numsweeps) use, intrinsic :: ISO_C_BINDING class(TpetraCrsMatrix), intent(in) :: self + class(TpetraMultiVector), intent(in) :: b + class(TpetraMultiVector), intent(inout) :: x + class(TpetraMultiVector), intent(in) :: d + real(C_DOUBLE), intent(in) :: dampingfactor -integer(kind(TpetraESweepDirection)), intent(in) :: direction +integer(TpetraESweepDirection), intent(in) :: direction integer(C_INT), intent(in) :: numsweeps + type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 type(SwigClassWrapper) :: farg3 @@ -9808,13 +10393,18 @@ subroutine swigf_TpetraCrsMatrix_gaussSeidel(self, b, x, d, dampingfactor, direc subroutine swigf_TpetraCrsMatrix_gaussSeidelCopy(self, x, b, d, dampingfactor, direction, numsweeps, zeroinitialguess) use, intrinsic :: ISO_C_BINDING class(TpetraCrsMatrix), intent(in) :: self + class(TpetraMultiVector), intent(inout) :: x + class(TpetraMultiVector), intent(in) :: b + class(TpetraMultiVector), intent(in) :: d + real(C_DOUBLE), intent(in) :: dampingfactor -integer(kind(TpetraESweepDirection)), intent(in) :: direction +integer(TpetraESweepDirection), intent(in) :: direction integer(C_INT), intent(in) :: numsweeps logical(C_BOOL), intent(in) :: zeroinitialguess + type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 type(SwigClassWrapper) :: farg3 @@ -9840,6 +10430,7 @@ function swigf_TpetraCrsMatrix_description(self) & use, intrinsic :: ISO_C_BINDING character(kind=C_CHAR, len=:), allocatable :: swig_result class(TpetraCrsMatrix), intent(in) :: self + type(SwigArrayWrapper) :: fresult type(SwigClassWrapper) :: farg1 @@ -9852,11 +10443,17 @@ function swigf_TpetraCrsMatrix_description(self) & subroutine swigf_TpetraCrsMatrix_importAndFillComplete__SWIG_0(self, destmatrix, importer, domainmap, rangemap, params) use, intrinsic :: ISO_C_BINDING class(TpetraCrsMatrix), intent(in) :: self + class(TpetraCrsMatrix), intent(inout) :: destmatrix + class(TpetraImport), intent(in) :: importer + class(TpetraMap), intent(in) :: domainmap + class(TpetraMap), intent(in) :: rangemap + class(ParameterList), intent(in) :: params + type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 type(SwigClassWrapper) :: farg3 @@ -9876,10 +10473,15 @@ subroutine swigf_TpetraCrsMatrix_importAndFillComplete__SWIG_0(self, destmatrix, subroutine swigf_TpetraCrsMatrix_importAndFillComplete__SWIG_1(self, destmatrix, importer, domainmap, rangemap) use, intrinsic :: ISO_C_BINDING class(TpetraCrsMatrix), intent(in) :: self + class(TpetraCrsMatrix), intent(inout) :: destmatrix + class(TpetraImport), intent(in) :: importer + class(TpetraMap), intent(in) :: domainmap + class(TpetraMap), intent(in) :: rangemap + type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 type(SwigClassWrapper) :: farg3 @@ -9898,12 +10500,19 @@ subroutine swigf_TpetraCrsMatrix_importAndFillComplete__SWIG_2(self, destmatrix, rangemap, params) use, intrinsic :: ISO_C_BINDING class(TpetraCrsMatrix), intent(in) :: self + class(TpetraCrsMatrix), intent(inout) :: destmatrix + class(TpetraImport), intent(in) :: rowimporter + class(TpetraImport), intent(in) :: domainimporter + class(TpetraMap), intent(in) :: domainmap + class(TpetraMap), intent(in) :: rangemap + class(ParameterList), intent(in) :: params + type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 type(SwigClassWrapper) :: farg3 @@ -9925,11 +10534,17 @@ subroutine swigf_TpetraCrsMatrix_importAndFillComplete__SWIG_2(self, destmatrix, subroutine swigf_TpetraCrsMatrix_exportAndFillComplete__SWIG_0(self, destmatrix, exporter, domainmap, rangemap, params) use, intrinsic :: ISO_C_BINDING class(TpetraCrsMatrix), intent(in) :: self + class(TpetraCrsMatrix), intent(inout) :: destmatrix + class(TpetraExport), intent(in) :: exporter + class(TpetraMap), intent(in) :: domainmap + class(TpetraMap), intent(in) :: rangemap + class(ParameterList), intent(in) :: params + type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 type(SwigClassWrapper) :: farg3 @@ -9949,10 +10564,15 @@ subroutine swigf_TpetraCrsMatrix_exportAndFillComplete__SWIG_0(self, destmatrix, subroutine swigf_TpetraCrsMatrix_exportAndFillComplete__SWIG_1(self, destmatrix, exporter, domainmap, rangemap) use, intrinsic :: ISO_C_BINDING class(TpetraCrsMatrix), intent(in) :: self + class(TpetraCrsMatrix), intent(inout) :: destmatrix + class(TpetraExport), intent(in) :: exporter + class(TpetraMap), intent(in) :: domainmap + class(TpetraMap), intent(in) :: rangemap + type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 type(SwigClassWrapper) :: farg3 @@ -9970,9 +10590,13 @@ subroutine swigf_TpetraCrsMatrix_exportAndFillComplete__SWIG_1(self, destmatrix, subroutine swigf_TpetraCrsMatrix_exportAndFillComplete__SWIG_2(self, destmatrix, exporter, domainmap) use, intrinsic :: ISO_C_BINDING class(TpetraCrsMatrix), intent(in) :: self + class(TpetraCrsMatrix), intent(inout) :: destmatrix + class(TpetraExport), intent(in) :: exporter + class(TpetraMap), intent(in) :: domainmap + type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 type(SwigClassWrapper) :: farg3 @@ -9988,8 +10612,11 @@ subroutine swigf_TpetraCrsMatrix_exportAndFillComplete__SWIG_2(self, destmatrix, subroutine swigf_TpetraCrsMatrix_exportAndFillComplete__SWIG_3(self, destmatrix, exporter) use, intrinsic :: ISO_C_BINDING class(TpetraCrsMatrix), intent(in) :: self + class(TpetraCrsMatrix), intent(inout) :: destmatrix + class(TpetraExport), intent(in) :: exporter + type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 type(SwigClassWrapper) :: farg3 @@ -10004,12 +10631,19 @@ subroutine swigf_TpetraCrsMatrix_exportAndFillComplete__SWIG_4(self, destmatrix, rangemap, params) use, intrinsic :: ISO_C_BINDING class(TpetraCrsMatrix), intent(in) :: self + class(TpetraCrsMatrix), intent(inout) :: destmatrix + class(TpetraExport), intent(in) :: rowexporter + class(TpetraExport), intent(in) :: domainexporter + class(TpetraMap), intent(in) :: domainmap + class(TpetraMap), intent(in) :: rangemap + class(ParameterList), intent(in) :: params + type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 type(SwigClassWrapper) :: farg3 @@ -10031,7 +10665,8 @@ subroutine swigf_TpetraCrsMatrix_exportAndFillComplete__SWIG_4(self, destmatrix, subroutine swigf_TpetraCrsMatrix_computeGlobalConstants(self) use, intrinsic :: ISO_C_BINDING class(TpetraCrsMatrix), intent(inout) :: self -type(SwigClassWrapper) :: farg1 + +type(SwigClassWrapper) :: farg1 farg1 = self%swigdata call swigc_TpetraCrsMatrix_computeGlobalConstants(farg1) @@ -10042,6 +10677,7 @@ function swigf_TpetraCrsMatrix_haveGlobalConstants(self) & use, intrinsic :: ISO_C_BINDING logical(C_BOOL) :: swig_result class(TpetraCrsMatrix), intent(in) :: self + logical(C_BOOL) :: fresult type(SwigClassWrapper) :: farg1 @@ -10055,10 +10691,12 @@ function new_TpetraCrsMatrix__SWIG_10(rowmap, numentriesperrowtoalloc, pftype, p use, intrinsic :: ISO_C_BINDING type(TpetraCrsMatrix) :: self class(TpetraMap), intent(in) :: rowmap + integer(C_SIZE_T), dimension(:), target :: numentriesperrowtoalloc integer(C_SIZE_T), pointer :: farg2_view -integer(kind(TpetraProfileType)), intent(in) :: pftype +integer(TpetraProfileType), intent(in) :: pftype class(ParameterList), intent(in) :: params + type(SwigClassWrapper) :: fresult type(SwigClassWrapper) :: farg1 type(SwigArrayWrapper) :: farg2 @@ -10080,9 +10718,11 @@ function new_TpetraCrsMatrix__SWIG_11(rowmap, numentriesperrowtoalloc, pftype) & use, intrinsic :: ISO_C_BINDING type(TpetraCrsMatrix) :: self class(TpetraMap), intent(in) :: rowmap + integer(C_SIZE_T), dimension(:), target :: numentriesperrowtoalloc integer(C_SIZE_T), pointer :: farg2_view -integer(kind(TpetraProfileType)), intent(in) :: pftype +integer(TpetraProfileType), intent(in) :: pftype + type(SwigClassWrapper) :: fresult type(SwigClassWrapper) :: farg1 type(SwigArrayWrapper) :: farg2 @@ -10102,8 +10742,10 @@ function new_TpetraCrsMatrix__SWIG_12(rowmap, numentriesperrowtoalloc) & use, intrinsic :: ISO_C_BINDING type(TpetraCrsMatrix) :: self class(TpetraMap), intent(in) :: rowmap + integer(C_SIZE_T), dimension(:), target :: numentriesperrowtoalloc integer(C_SIZE_T), pointer :: farg2_view + type(SwigClassWrapper) :: fresult type(SwigClassWrapper) :: farg1 type(SwigArrayWrapper) :: farg2 @@ -10121,11 +10763,14 @@ function new_TpetraCrsMatrix__SWIG_13(rowmap, colmap, numentriesperrowtoalloc, p use, intrinsic :: ISO_C_BINDING type(TpetraCrsMatrix) :: self class(TpetraMap), intent(in) :: rowmap + class(TpetraMap), intent(in) :: colmap + integer(C_SIZE_T), dimension(:), target :: numentriesperrowtoalloc integer(C_SIZE_T), pointer :: farg3_view -integer(kind(TpetraProfileType)), intent(in) :: pftype +integer(TpetraProfileType), intent(in) :: pftype class(ParameterList), intent(in) :: params + type(SwigClassWrapper) :: fresult type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 @@ -10149,10 +10794,13 @@ function new_TpetraCrsMatrix__SWIG_14(rowmap, colmap, numentriesperrowtoalloc, p use, intrinsic :: ISO_C_BINDING type(TpetraCrsMatrix) :: self class(TpetraMap), intent(in) :: rowmap + class(TpetraMap), intent(in) :: colmap + integer(C_SIZE_T), dimension(:), target :: numentriesperrowtoalloc integer(C_SIZE_T), pointer :: farg3_view -integer(kind(TpetraProfileType)), intent(in) :: pftype +integer(TpetraProfileType), intent(in) :: pftype + type(SwigClassWrapper) :: fresult type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 @@ -10174,9 +10822,12 @@ function new_TpetraCrsMatrix__SWIG_15(rowmap, colmap, numentriesperrowtoalloc) & use, intrinsic :: ISO_C_BINDING type(TpetraCrsMatrix) :: self class(TpetraMap), intent(in) :: rowmap + class(TpetraMap), intent(in) :: colmap + integer(C_SIZE_T), dimension(:), target :: numentriesperrowtoalloc integer(C_SIZE_T), pointer :: farg3_view + type(SwigClassWrapper) :: fresult type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 @@ -10196,7 +10847,9 @@ function new_TpetraCrsMatrix__SWIG_16(rowmap, colmap, rowpointers, columnindices use, intrinsic :: ISO_C_BINDING type(TpetraCrsMatrix) :: self class(TpetraMap), intent(in) :: rowmap + class(TpetraMap), intent(in) :: colmap + integer(C_SIZE_T), dimension(:), target :: rowpointers integer(C_SIZE_T), pointer :: farg3_view integer(C_INT), dimension(:), target :: columnindices @@ -10204,6 +10857,7 @@ function new_TpetraCrsMatrix__SWIG_16(rowmap, colmap, rowpointers, columnindices real(C_DOUBLE), dimension(:), target :: values real(C_DOUBLE), pointer :: farg5_view class(ParameterList), intent(in) :: params + type(SwigClassWrapper) :: fresult type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 @@ -10233,13 +10887,16 @@ function new_TpetraCrsMatrix__SWIG_17(rowmap, colmap, rowpointers, columnindices use, intrinsic :: ISO_C_BINDING type(TpetraCrsMatrix) :: self class(TpetraMap), intent(in) :: rowmap + class(TpetraMap), intent(in) :: colmap + integer(C_SIZE_T), dimension(:), target :: rowpointers integer(C_SIZE_T), pointer :: farg3_view integer(C_INT), dimension(:), target :: columnindices integer(C_INT), pointer :: farg4_view real(C_DOUBLE), dimension(:), target :: values real(C_DOUBLE), pointer :: farg5_view + type(SwigClassWrapper) :: fresult type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 @@ -10265,11 +10922,13 @@ function new_TpetraCrsMatrix__SWIG_17(rowmap, colmap, rowpointers, columnindices subroutine swigf_TpetraCrsMatrix_insertGlobalValues(self, globalrow, cols, vals) use, intrinsic :: ISO_C_BINDING class(TpetraCrsMatrix), intent(inout) :: self + integer(C_LONG_LONG), intent(in) :: globalrow integer(C_LONG_LONG), dimension(:), target :: cols integer(C_LONG_LONG), pointer :: farg3_view real(C_DOUBLE), dimension(:), target :: vals real(C_DOUBLE), pointer :: farg4_view + type(SwigClassWrapper) :: farg1 integer(C_LONG_LONG) :: farg2 type(SwigArrayWrapper) :: farg3 @@ -10289,11 +10948,13 @@ subroutine swigf_TpetraCrsMatrix_insertGlobalValues(self, globalrow, cols, vals) subroutine swigf_TpetraCrsMatrix_insertLocalValues(self, localrow, cols, vals) use, intrinsic :: ISO_C_BINDING class(TpetraCrsMatrix), intent(inout) :: self + integer(C_INT), intent(in) :: localrow integer(C_INT), dimension(:), target :: cols integer(C_INT), pointer :: farg3_view real(C_DOUBLE), dimension(:), target :: vals real(C_DOUBLE), pointer :: farg4_view + type(SwigClassWrapper) :: farg1 integer(C_INT) :: farg2 type(SwigArrayWrapper) :: farg3 @@ -10315,11 +10976,13 @@ function swigf_TpetraCrsMatrix_replaceGlobalValues(self, globalrow, cols, vals) use, intrinsic :: ISO_C_BINDING integer(C_INT) :: swig_result class(TpetraCrsMatrix), intent(in) :: self + integer(C_LONG_LONG), intent(in) :: globalrow integer(C_LONG_LONG), dimension(:), target :: cols integer(C_LONG_LONG), pointer :: farg3_view real(C_DOUBLE), dimension(:), target :: vals real(C_DOUBLE), pointer :: farg4_view + integer(C_INT) :: fresult type(SwigClassWrapper) :: farg1 integer(C_LONG_LONG) :: farg2 @@ -10343,11 +11006,13 @@ function swigf_TpetraCrsMatrix_sumIntoGlobalValues(self, globalrow, cols, vals) use, intrinsic :: ISO_C_BINDING integer(C_INT) :: swig_result class(TpetraCrsMatrix), intent(inout) :: self + integer(C_LONG_LONG), intent(in) :: globalrow integer(C_LONG_LONG), dimension(:), target :: cols integer(C_LONG_LONG), pointer :: farg3_view real(C_DOUBLE), dimension(:), target :: vals real(C_DOUBLE), pointer :: farg4_view + integer(C_INT) :: fresult type(SwigClassWrapper) :: farg1 integer(C_LONG_LONG) :: farg2 @@ -10369,12 +11034,14 @@ function swigf_TpetraCrsMatrix_sumIntoGlobalValues(self, globalrow, cols, vals) subroutine swigf_TpetraCrsMatrix_setAllValues(self, ptr, ind, val) use, intrinsic :: ISO_C_BINDING class(TpetraCrsMatrix), intent(inout) :: self + integer(C_SIZE_T), dimension(:), target :: ptr integer(C_SIZE_T), pointer :: farg2_view integer(C_INT), dimension(:), target :: ind integer(C_INT), pointer :: farg3_view real(C_DOUBLE), dimension(:), target :: val real(C_DOUBLE), pointer :: farg4_view + type(SwigClassWrapper) :: farg1 type(SwigArrayWrapper) :: farg2 type(SwigArrayWrapper) :: farg3 @@ -10396,12 +11063,14 @@ subroutine swigf_TpetraCrsMatrix_setAllValues(self, ptr, ind, val) subroutine swigf_TpetraCrsMatrix_getAllValues(self, rowpointers, columnindices, values) use, intrinsic :: ISO_C_BINDING class(TpetraCrsMatrix), intent(in) :: self + integer(C_SIZE_T), dimension(:), target :: rowpointers integer(C_SIZE_T), pointer :: farg2_view integer(C_INT), dimension(:), target :: columnindices integer(C_INT), pointer :: farg3_view real(C_DOUBLE), dimension(:), target :: values real(C_DOUBLE), pointer :: farg4_view + type(SwigClassWrapper) :: farg1 type(SwigArrayWrapper) :: farg2 type(SwigArrayWrapper) :: farg3 @@ -10423,12 +11092,14 @@ subroutine swigf_TpetraCrsMatrix_getAllValues(self, rowpointers, columnindices, subroutine swigf_TpetraCrsMatrix_getGlobalRowCopy(self, globalrow, indices, values, numindices) use, intrinsic :: ISO_C_BINDING class(TpetraCrsMatrix), intent(in) :: self + integer(C_LONG_LONG), intent(in) :: globalrow integer(C_LONG_LONG), dimension(:), target :: indices integer(C_LONG_LONG), pointer :: farg3_view real(C_DOUBLE), dimension(:), target :: values real(C_DOUBLE), pointer :: farg4_view integer(C_SIZE_T), target, intent(inout) :: numindices + type(SwigClassWrapper) :: farg1 integer(C_LONG_LONG) :: farg2 type(SwigArrayWrapper) :: farg3 @@ -10450,12 +11121,14 @@ subroutine swigf_TpetraCrsMatrix_getGlobalRowCopy(self, globalrow, indices, valu subroutine swigf_TpetraCrsMatrix_getLocalRowCopy(self, localrow, colinds, vals, numindices) use, intrinsic :: ISO_C_BINDING class(TpetraCrsMatrix), intent(in) :: self + integer(C_INT), intent(in) :: localrow integer(C_INT), dimension(:), target :: colinds integer(C_INT), pointer :: farg3_view real(C_DOUBLE), dimension(:), target :: vals real(C_DOUBLE), pointer :: farg4_view integer(C_SIZE_T), target, intent(inout) :: numindices + type(SwigClassWrapper) :: farg1 integer(C_INT) :: farg2 type(SwigArrayWrapper) :: farg3 @@ -10477,11 +11150,13 @@ subroutine swigf_TpetraCrsMatrix_getLocalRowCopy(self, localrow, colinds, vals, subroutine swigf_TpetraCrsMatrix_getGlobalRowView(self, globalrow, indices, values) use, intrinsic :: ISO_C_BINDING class(TpetraCrsMatrix), intent(in) :: self + integer(C_LONG_LONG), intent(in) :: globalrow integer(C_LONG_LONG), dimension(:), target :: indices integer(C_LONG_LONG), pointer :: farg3_view real(C_DOUBLE), dimension(:), target :: values real(C_DOUBLE), pointer :: farg4_view + type(SwigClassWrapper) :: farg1 integer(C_LONG_LONG) :: farg2 type(SwigArrayWrapper) :: farg3 @@ -10501,8 +11176,10 @@ subroutine swigf_TpetraCrsMatrix_getGlobalRowView(self, globalrow, indices, valu subroutine swigf_TpetraCrsMatrix_getLocalDiagOffsets(self, offsets) use, intrinsic :: ISO_C_BINDING class(TpetraCrsMatrix), intent(in) :: self + integer(C_SIZE_T), dimension(:), target :: offsets integer(C_SIZE_T), pointer :: farg2_view + type(SwigClassWrapper) :: farg1 type(SwigArrayWrapper) :: farg2 @@ -10516,9 +11193,13 @@ subroutine swigf_TpetraCrsMatrix_getLocalDiagOffsets(self, offsets) subroutine swigf_TpetraCrsMatrix_doImport__SWIG_0(self, source, importer, cm) use, intrinsic :: ISO_C_BINDING class(TpetraCrsMatrix), intent(inout) :: self + class(TpetraCrsMatrix), intent(in) :: source + class(TpetraImport), intent(in) :: importer -integer(kind(TpetraCombineMode)), intent(in) :: cm + +integer(TpetraCombineMode), intent(in) :: cm + type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 type(SwigClassWrapper) :: farg3 @@ -10534,9 +11215,13 @@ subroutine swigf_TpetraCrsMatrix_doImport__SWIG_0(self, source, importer, cm) subroutine swigf_TpetraCrsMatrix_doImport__SWIG_1(self, source, exporter, cm) use, intrinsic :: ISO_C_BINDING class(TpetraCrsMatrix), intent(inout) :: self + class(TpetraCrsMatrix), intent(in) :: source + class(TpetraExport), intent(in) :: exporter -integer(kind(TpetraCombineMode)), intent(in) :: cm + +integer(TpetraCombineMode), intent(in) :: cm + type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 type(SwigClassWrapper) :: farg3 @@ -10552,9 +11237,13 @@ subroutine swigf_TpetraCrsMatrix_doImport__SWIG_1(self, source, exporter, cm) subroutine swigf_TpetraCrsMatrix_doExport__SWIG_0(self, source, exporter, cm) use, intrinsic :: ISO_C_BINDING class(TpetraCrsMatrix), intent(inout) :: self + class(TpetraCrsMatrix), intent(in) :: source + class(TpetraExport), intent(in) :: exporter -integer(kind(TpetraCombineMode)), intent(in) :: cm + +integer(TpetraCombineMode), intent(in) :: cm + type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 type(SwigClassWrapper) :: farg3 @@ -10570,9 +11259,13 @@ subroutine swigf_TpetraCrsMatrix_doExport__SWIG_0(self, source, exporter, cm) subroutine swigf_TpetraCrsMatrix_doExport__SWIG_1(self, source, importer, cm) use, intrinsic :: ISO_C_BINDING class(TpetraCrsMatrix), intent(inout) :: self + class(TpetraCrsMatrix), intent(in) :: source + class(TpetraImport), intent(in) :: importer -integer(kind(TpetraCombineMode)), intent(in) :: cm + +integer(TpetraCombineMode), intent(in) :: cm + type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 type(SwigClassWrapper) :: farg3 @@ -10596,6 +11289,7 @@ function operator_to_matrix(op) & use, intrinsic :: ISO_C_BINDING type(TpetraCrsMatrix) :: swig_result class(TpetraOperator), intent(inout) :: op + type(SwigClassWrapper) :: fresult type(SwigClassWrapper) :: farg1 @@ -10609,6 +11303,7 @@ function matrix_to_operator(a) & use, intrinsic :: ISO_C_BINDING type(TpetraOperator) :: swig_result class(TpetraCrsMatrix), intent(inout) :: a + type(SwigClassWrapper) :: fresult type(SwigClassWrapper) :: farg1 @@ -10624,9 +11319,11 @@ function TpetraReader_readSparseGraphFile__SWIG_0(filename, pcomm, callfillcompl character(kind=C_CHAR, len=*), target :: filename character(kind=C_CHAR), dimension(:), allocatable, target :: farg1_chars class(TeuchosComm), intent(in) :: pcomm + logical(C_BOOL), intent(in) :: callfillcomplete logical(C_BOOL), intent(in) :: tolerant logical(C_BOOL), intent(in) :: debug + type(SwigClassWrapper) :: fresult type(SwigArrayWrapper) :: farg1 type(SwigClassWrapper) :: farg2 @@ -10650,8 +11347,10 @@ function TpetraReader_readSparseGraphFile__SWIG_1(filename, pcomm, callfillcompl character(kind=C_CHAR, len=*), target :: filename character(kind=C_CHAR), dimension(:), allocatable, target :: farg1_chars class(TeuchosComm), intent(in) :: pcomm + logical(C_BOOL), intent(in) :: callfillcomplete logical(C_BOOL), intent(in) :: tolerant + type(SwigClassWrapper) :: fresult type(SwigArrayWrapper) :: farg1 type(SwigClassWrapper) :: farg2 @@ -10673,7 +11372,9 @@ function TpetraReader_readSparseGraphFile__SWIG_2(filename, pcomm, callfillcompl character(kind=C_CHAR, len=*), target :: filename character(kind=C_CHAR), dimension(:), allocatable, target :: farg1_chars class(TeuchosComm), intent(in) :: pcomm + logical(C_BOOL), intent(in) :: callfillcomplete + type(SwigClassWrapper) :: fresult type(SwigArrayWrapper) :: farg1 type(SwigClassWrapper) :: farg2 @@ -10693,6 +11394,7 @@ function TpetraReader_readSparseGraphFile__SWIG_3(filename, pcomm) & character(kind=C_CHAR, len=*), target :: filename character(kind=C_CHAR), dimension(:), allocatable, target :: farg1_chars class(TeuchosComm), intent(in) :: pcomm + type(SwigClassWrapper) :: fresult type(SwigArrayWrapper) :: farg1 type(SwigClassWrapper) :: farg2 @@ -10710,10 +11412,14 @@ function TpetraReader_readSparseGraphFile__SWIG_4(filename, pcomm, constructorpa character(kind=C_CHAR, len=*), target :: filename character(kind=C_CHAR), dimension(:), allocatable, target :: farg1_chars class(TeuchosComm), intent(in) :: pcomm + class(ParameterList), intent(in) :: constructorparams + class(ParameterList), intent(in) :: fillcompleteparams + logical(C_BOOL), intent(in) :: tolerant logical(C_BOOL), intent(in) :: debug + type(SwigClassWrapper) :: fresult type(SwigArrayWrapper) :: farg1 type(SwigClassWrapper) :: farg2 @@ -10739,9 +11445,13 @@ function TpetraReader_readSparseGraphFile__SWIG_5(filename, pcomm, constructorpa character(kind=C_CHAR, len=*), target :: filename character(kind=C_CHAR), dimension(:), allocatable, target :: farg1_chars class(TeuchosComm), intent(in) :: pcomm + class(ParameterList), intent(in) :: constructorparams + class(ParameterList), intent(in) :: fillcompleteparams + logical(C_BOOL), intent(in) :: tolerant + type(SwigClassWrapper) :: fresult type(SwigArrayWrapper) :: farg1 type(SwigClassWrapper) :: farg2 @@ -10765,8 +11475,11 @@ function TpetraReader_readSparseGraphFile__SWIG_6(filename, pcomm, constructorpa character(kind=C_CHAR, len=*), target :: filename character(kind=C_CHAR), dimension(:), allocatable, target :: farg1_chars class(TeuchosComm), intent(in) :: pcomm + class(ParameterList), intent(in) :: constructorparams + class(ParameterList), intent(in) :: fillcompleteparams + type(SwigClassWrapper) :: fresult type(SwigArrayWrapper) :: farg1 type(SwigClassWrapper) :: farg2 @@ -10789,12 +11502,17 @@ function TpetraReader_readSparseGraphFile__SWIG_7(filename, rowmap, colmap, doma character(kind=C_CHAR, len=*), target :: filename character(kind=C_CHAR), dimension(:), allocatable, target :: farg1_chars class(TpetraMap), intent(in) :: rowmap + class(TpetraMap), intent(inout) :: colmap + class(TpetraMap), intent(in) :: domainmap + class(TpetraMap), intent(in) :: rangemap + logical(C_BOOL), intent(in) :: callfillcomplete logical(C_BOOL), intent(in) :: tolerant logical(C_BOOL), intent(in) :: debug + type(SwigClassWrapper) :: fresult type(SwigArrayWrapper) :: farg1 type(SwigClassWrapper) :: farg2 @@ -10824,11 +11542,16 @@ function TpetraReader_readSparseGraphFile__SWIG_8(filename, rowmap, colmap, doma character(kind=C_CHAR, len=*), target :: filename character(kind=C_CHAR), dimension(:), allocatable, target :: farg1_chars class(TpetraMap), intent(in) :: rowmap + class(TpetraMap), intent(inout) :: colmap + class(TpetraMap), intent(in) :: domainmap + class(TpetraMap), intent(in) :: rangemap + logical(C_BOOL), intent(in) :: callfillcomplete logical(C_BOOL), intent(in) :: tolerant + type(SwigClassWrapper) :: fresult type(SwigArrayWrapper) :: farg1 type(SwigClassWrapper) :: farg2 @@ -10856,10 +11579,15 @@ function TpetraReader_readSparseGraphFile__SWIG_9(filename, rowmap, colmap, doma character(kind=C_CHAR, len=*), target :: filename character(kind=C_CHAR), dimension(:), allocatable, target :: farg1_chars class(TpetraMap), intent(in) :: rowmap + class(TpetraMap), intent(inout) :: colmap + class(TpetraMap), intent(in) :: domainmap + class(TpetraMap), intent(in) :: rangemap + logical(C_BOOL), intent(in) :: callfillcomplete + type(SwigClassWrapper) :: fresult type(SwigArrayWrapper) :: farg1 type(SwigClassWrapper) :: farg2 @@ -10885,9 +11613,13 @@ function TpetraReader_readSparseGraphFile__SWIG_10(filename, rowmap, colmap, dom character(kind=C_CHAR, len=*), target :: filename character(kind=C_CHAR), dimension(:), allocatable, target :: farg1_chars class(TpetraMap), intent(in) :: rowmap + class(TpetraMap), intent(inout) :: colmap + class(TpetraMap), intent(in) :: domainmap + class(TpetraMap), intent(in) :: rangemap + type(SwigClassWrapper) :: fresult type(SwigArrayWrapper) :: farg1 type(SwigClassWrapper) :: farg2 @@ -10911,9 +11643,11 @@ function TpetraReader_readSparseFile__SWIG_0(filename, pcomm, callfillcomplete, character(kind=C_CHAR, len=*), target :: filename character(kind=C_CHAR), dimension(:), allocatable, target :: farg1_chars class(TeuchosComm), intent(in) :: pcomm + logical(C_BOOL), intent(in) :: callfillcomplete logical(C_BOOL), intent(in) :: tolerant logical(C_BOOL), intent(in) :: debug + type(SwigClassWrapper) :: fresult type(SwigArrayWrapper) :: farg1 type(SwigClassWrapper) :: farg2 @@ -10937,8 +11671,10 @@ function TpetraReader_readSparseFile__SWIG_1(filename, pcomm, callfillcomplete, character(kind=C_CHAR, len=*), target :: filename character(kind=C_CHAR), dimension(:), allocatable, target :: farg1_chars class(TeuchosComm), intent(in) :: pcomm + logical(C_BOOL), intent(in) :: callfillcomplete logical(C_BOOL), intent(in) :: tolerant + type(SwigClassWrapper) :: fresult type(SwigArrayWrapper) :: farg1 type(SwigClassWrapper) :: farg2 @@ -10960,7 +11696,9 @@ function TpetraReader_readSparseFile__SWIG_2(filename, pcomm, callfillcomplete) character(kind=C_CHAR, len=*), target :: filename character(kind=C_CHAR), dimension(:), allocatable, target :: farg1_chars class(TeuchosComm), intent(in) :: pcomm + logical(C_BOOL), intent(in) :: callfillcomplete + type(SwigClassWrapper) :: fresult type(SwigArrayWrapper) :: farg1 type(SwigClassWrapper) :: farg2 @@ -10980,6 +11718,7 @@ function TpetraReader_readSparseFile__SWIG_3(filename, pcomm) & character(kind=C_CHAR, len=*), target :: filename character(kind=C_CHAR), dimension(:), allocatable, target :: farg1_chars class(TeuchosComm), intent(in) :: pcomm + type(SwigClassWrapper) :: fresult type(SwigArrayWrapper) :: farg1 type(SwigClassWrapper) :: farg2 @@ -10997,10 +11736,14 @@ function TpetraReader_readSparseFile__SWIG_4(filename, pcomm, constructorparams, character(kind=C_CHAR, len=*), target :: filename character(kind=C_CHAR), dimension(:), allocatable, target :: farg1_chars class(TeuchosComm), intent(in) :: pcomm + class(ParameterList), intent(in) :: constructorparams + class(ParameterList), intent(in) :: fillcompleteparams + logical(C_BOOL), intent(in) :: tolerant logical(C_BOOL), intent(in) :: debug + type(SwigClassWrapper) :: fresult type(SwigArrayWrapper) :: farg1 type(SwigClassWrapper) :: farg2 @@ -11026,9 +11769,13 @@ function TpetraReader_readSparseFile__SWIG_5(filename, pcomm, constructorparams, character(kind=C_CHAR, len=*), target :: filename character(kind=C_CHAR), dimension(:), allocatable, target :: farg1_chars class(TeuchosComm), intent(in) :: pcomm + class(ParameterList), intent(in) :: constructorparams + class(ParameterList), intent(in) :: fillcompleteparams + logical(C_BOOL), intent(in) :: tolerant + type(SwigClassWrapper) :: fresult type(SwigArrayWrapper) :: farg1 type(SwigClassWrapper) :: farg2 @@ -11052,8 +11799,11 @@ function TpetraReader_readSparseFile__SWIG_6(filename, pcomm, constructorparams, character(kind=C_CHAR, len=*), target :: filename character(kind=C_CHAR), dimension(:), allocatable, target :: farg1_chars class(TeuchosComm), intent(in) :: pcomm + class(ParameterList), intent(in) :: constructorparams + class(ParameterList), intent(in) :: fillcompleteparams + type(SwigClassWrapper) :: fresult type(SwigArrayWrapper) :: farg1 type(SwigClassWrapper) :: farg2 @@ -11075,12 +11825,17 @@ function TpetraReader_readSparseFile__SWIG_7(filename, rowmap, colmap, domainmap character(kind=C_CHAR, len=*), target :: filename character(kind=C_CHAR), dimension(:), allocatable, target :: farg1_chars class(TpetraMap), intent(in) :: rowmap + class(TpetraMap), intent(inout) :: colmap + class(TpetraMap), intent(in) :: domainmap + class(TpetraMap), intent(in) :: rangemap + logical(C_BOOL), intent(in) :: callfillcomplete logical(C_BOOL), intent(in) :: tolerant logical(C_BOOL), intent(in) :: debug + type(SwigClassWrapper) :: fresult type(SwigArrayWrapper) :: farg1 type(SwigClassWrapper) :: farg2 @@ -11110,11 +11865,16 @@ function TpetraReader_readSparseFile__SWIG_8(filename, rowmap, colmap, domainmap character(kind=C_CHAR, len=*), target :: filename character(kind=C_CHAR), dimension(:), allocatable, target :: farg1_chars class(TpetraMap), intent(in) :: rowmap + class(TpetraMap), intent(inout) :: colmap + class(TpetraMap), intent(in) :: domainmap + class(TpetraMap), intent(in) :: rangemap + logical(C_BOOL), intent(in) :: callfillcomplete logical(C_BOOL), intent(in) :: tolerant + type(SwigClassWrapper) :: fresult type(SwigArrayWrapper) :: farg1 type(SwigClassWrapper) :: farg2 @@ -11142,10 +11902,15 @@ function TpetraReader_readSparseFile__SWIG_9(filename, rowmap, colmap, domainmap character(kind=C_CHAR, len=*), target :: filename character(kind=C_CHAR), dimension(:), allocatable, target :: farg1_chars class(TpetraMap), intent(in) :: rowmap + class(TpetraMap), intent(inout) :: colmap + class(TpetraMap), intent(in) :: domainmap + class(TpetraMap), intent(in) :: rangemap + logical(C_BOOL), intent(in) :: callfillcomplete + type(SwigClassWrapper) :: fresult type(SwigArrayWrapper) :: farg1 type(SwigClassWrapper) :: farg2 @@ -11171,9 +11936,13 @@ function TpetraReader_readSparseFile__SWIG_10(filename, rowmap, colmap, domainma character(kind=C_CHAR, len=*), target :: filename character(kind=C_CHAR), dimension(:), allocatable, target :: farg1_chars class(TpetraMap), intent(in) :: rowmap + class(TpetraMap), intent(inout) :: colmap + class(TpetraMap), intent(in) :: domainmap + class(TpetraMap), intent(in) :: rangemap + type(SwigClassWrapper) :: fresult type(SwigArrayWrapper) :: farg1 type(SwigClassWrapper) :: farg2 @@ -11197,9 +11966,12 @@ function TpetraReader_readDenseFile__SWIG_0(filename, comm, map, tolerant, debug character(kind=C_CHAR, len=*), target :: filename character(kind=C_CHAR), dimension(:), allocatable, target :: farg1_chars class(TeuchosComm), intent(in) :: comm + class(TpetraMap), intent(inout) :: map + logical(C_BOOL), intent(in) :: tolerant logical(C_BOOL), intent(in) :: debug + type(SwigClassWrapper) :: fresult type(SwigArrayWrapper) :: farg1 type(SwigClassWrapper) :: farg2 @@ -11223,8 +11995,11 @@ function TpetraReader_readDenseFile__SWIG_1(filename, comm, map, tolerant) & character(kind=C_CHAR, len=*), target :: filename character(kind=C_CHAR), dimension(:), allocatable, target :: farg1_chars class(TeuchosComm), intent(in) :: comm + class(TpetraMap), intent(inout) :: map + logical(C_BOOL), intent(in) :: tolerant + type(SwigClassWrapper) :: fresult type(SwigArrayWrapper) :: farg1 type(SwigClassWrapper) :: farg2 @@ -11246,7 +12021,9 @@ function TpetraReader_readDenseFile__SWIG_2(filename, comm, map) & character(kind=C_CHAR, len=*), target :: filename character(kind=C_CHAR), dimension(:), allocatable, target :: farg1_chars class(TeuchosComm), intent(in) :: comm + class(TpetraMap), intent(inout) :: map + type(SwigClassWrapper) :: fresult type(SwigArrayWrapper) :: farg1 type(SwigClassWrapper) :: farg2 @@ -11266,8 +12043,10 @@ function TpetraReader_readMapFile__SWIG_0(filename, comm, tolerant, debug) & character(kind=C_CHAR, len=*), target :: filename character(kind=C_CHAR), dimension(:), allocatable, target :: farg1_chars class(TeuchosComm), intent(in) :: comm + logical(C_BOOL), intent(in) :: tolerant logical(C_BOOL), intent(in) :: debug + type(SwigClassWrapper) :: fresult type(SwigArrayWrapper) :: farg1 type(SwigClassWrapper) :: farg2 @@ -11289,7 +12068,9 @@ function TpetraReader_readMapFile__SWIG_1(filename, comm, tolerant) & character(kind=C_CHAR, len=*), target :: filename character(kind=C_CHAR), dimension(:), allocatable, target :: farg1_chars class(TeuchosComm), intent(in) :: comm + logical(C_BOOL), intent(in) :: tolerant + type(SwigClassWrapper) :: fresult type(SwigArrayWrapper) :: farg1 type(SwigClassWrapper) :: farg2 @@ -11309,6 +12090,7 @@ function TpetraReader_readMapFile__SWIG_2(filename, comm) & character(kind=C_CHAR, len=*), target :: filename character(kind=C_CHAR), dimension(:), allocatable, target :: farg1_chars class(TeuchosComm), intent(in) :: comm + type(SwigClassWrapper) :: fresult type(SwigArrayWrapper) :: farg1 type(SwigClassWrapper) :: farg2 @@ -11323,6 +12105,7 @@ function new_TpetraReader() & result(self) use, intrinsic :: ISO_C_BINDING type(TpetraReader) :: self + type(SwigClassWrapper) :: fresult fresult = swigc_new_TpetraReader() @@ -11332,13 +12115,14 @@ function new_TpetraReader() & subroutine delete_TpetraReader(self) use, intrinsic :: ISO_C_BINDING class(TpetraReader), intent(inout) :: self + type(SwigClassWrapper) :: farg1 farg1 = self%swigdata if (self%swigdata%mem == SWIG_OWN) then call swigc_delete_TpetraReader(farg1) end if -self%swigdata%ptr = C_NULL_PTR +self%swigdata%cptr = C_NULL_PTR self%swigdata%mem = SWIG_NULL end subroutine @@ -11353,6 +12137,7 @@ subroutine TpetraWriter_writeMapFile(filename, map) character(kind=C_CHAR, len=*), target :: filename character(kind=C_CHAR), dimension(:), allocatable, target :: farg1_chars class(TpetraMap), intent(in) :: map + type(SwigArrayWrapper) :: farg1 type(SwigClassWrapper) :: farg2 @@ -11366,11 +12151,13 @@ subroutine TpetraWriter_writeSparseFile__SWIG_0(filename, pmatrix, matrixname, m character(kind=C_CHAR, len=*), target :: filename character(kind=C_CHAR), dimension(:), allocatable, target :: farg1_chars class(TpetraCrsMatrix), intent(in) :: pmatrix + character(kind=C_CHAR, len=*), target :: matrixname character(kind=C_CHAR), dimension(:), allocatable, target :: farg3_chars character(kind=C_CHAR, len=*), target :: matrixdescription character(kind=C_CHAR), dimension(:), allocatable, target :: farg4_chars logical(C_BOOL), intent(in) :: debug + type(SwigArrayWrapper) :: farg1 type(SwigClassWrapper) :: farg2 type(SwigArrayWrapper) :: farg3 @@ -11390,10 +12177,12 @@ subroutine TpetraWriter_writeSparseFile__SWIG_1(filename, pmatrix, matrixname, m character(kind=C_CHAR, len=*), target :: filename character(kind=C_CHAR), dimension(:), allocatable, target :: farg1_chars class(TpetraCrsMatrix), intent(in) :: pmatrix + character(kind=C_CHAR, len=*), target :: matrixname character(kind=C_CHAR), dimension(:), allocatable, target :: farg3_chars character(kind=C_CHAR, len=*), target :: matrixdescription character(kind=C_CHAR), dimension(:), allocatable, target :: farg4_chars + type(SwigArrayWrapper) :: farg1 type(SwigClassWrapper) :: farg2 type(SwigArrayWrapper) :: farg3 @@ -11411,7 +12200,9 @@ subroutine TpetraWriter_writeSparseFile__SWIG_2(filename, pmatrix, debug) character(kind=C_CHAR, len=*), target :: filename character(kind=C_CHAR), dimension(:), allocatable, target :: farg1_chars class(TpetraCrsMatrix), intent(in) :: pmatrix + logical(C_BOOL), intent(in) :: debug + type(SwigArrayWrapper) :: farg1 type(SwigClassWrapper) :: farg2 logical(C_BOOL) :: farg3 @@ -11427,6 +12218,7 @@ subroutine TpetraWriter_writeSparseFile__SWIG_3(filename, pmatrix) character(kind=C_CHAR, len=*), target :: filename character(kind=C_CHAR), dimension(:), allocatable, target :: farg1_chars class(TpetraCrsMatrix), intent(in) :: pmatrix + type(SwigArrayWrapper) :: farg1 type(SwigClassWrapper) :: farg2 @@ -11440,11 +12232,13 @@ subroutine TpetraWriter_writeSparseGraphFile__SWIG_0(filename, pgraph, graphname character(kind=C_CHAR, len=*), target :: filename character(kind=C_CHAR), dimension(:), allocatable, target :: farg1_chars class(TpetraCrsGraph), intent(in) :: pgraph + character(kind=C_CHAR, len=*), target :: graphname character(kind=C_CHAR), dimension(:), allocatable, target :: farg3_chars character(kind=C_CHAR, len=*), target :: graphdescription character(kind=C_CHAR), dimension(:), allocatable, target :: farg4_chars logical(C_BOOL), intent(in) :: debug + type(SwigArrayWrapper) :: farg1 type(SwigClassWrapper) :: farg2 type(SwigArrayWrapper) :: farg3 @@ -11464,10 +12258,12 @@ subroutine TpetraWriter_writeSparseGraphFile__SWIG_1(filename, pgraph, graphname character(kind=C_CHAR, len=*), target :: filename character(kind=C_CHAR), dimension(:), allocatable, target :: farg1_chars class(TpetraCrsGraph), intent(in) :: pgraph + character(kind=C_CHAR, len=*), target :: graphname character(kind=C_CHAR), dimension(:), allocatable, target :: farg3_chars character(kind=C_CHAR, len=*), target :: graphdescription character(kind=C_CHAR), dimension(:), allocatable, target :: farg4_chars + type(SwigArrayWrapper) :: farg1 type(SwigClassWrapper) :: farg2 type(SwigArrayWrapper) :: farg3 @@ -11485,7 +12281,9 @@ subroutine TpetraWriter_writeSparseGraphFile__SWIG_2(filename, pgraph, debug) character(kind=C_CHAR, len=*), target :: filename character(kind=C_CHAR), dimension(:), allocatable, target :: farg1_chars class(TpetraCrsGraph), intent(in) :: pgraph + logical(C_BOOL), intent(in) :: debug + type(SwigArrayWrapper) :: farg1 type(SwigClassWrapper) :: farg2 logical(C_BOOL) :: farg3 @@ -11501,6 +12299,7 @@ subroutine TpetraWriter_writeSparseGraphFile__SWIG_3(filename, pgraph) character(kind=C_CHAR, len=*), target :: filename character(kind=C_CHAR), dimension(:), allocatable, target :: farg1_chars class(TpetraCrsGraph), intent(in) :: pgraph + type(SwigArrayWrapper) :: farg1 type(SwigClassWrapper) :: farg2 @@ -11514,10 +12313,12 @@ subroutine TpetraWriter_writeDenseFile__SWIG_0(filename, x, matrixname, matrixde character(kind=C_CHAR, len=*), target :: filename character(kind=C_CHAR), dimension(:), allocatable, target :: farg1_chars class(TpetraMultiVector), intent(in) :: x + character(kind=C_CHAR, len=*), target :: matrixname character(kind=C_CHAR), dimension(:), allocatable, target :: farg3_chars character(kind=C_CHAR, len=*), target :: matrixdescription character(kind=C_CHAR), dimension(:), allocatable, target :: farg4_chars + type(SwigArrayWrapper) :: farg1 type(SwigClassWrapper) :: farg2 type(SwigArrayWrapper) :: farg3 @@ -11535,6 +12336,7 @@ subroutine TpetraWriter_writeDenseFile__SWIG_1(filename, x) character(kind=C_CHAR, len=*), target :: filename character(kind=C_CHAR), dimension(:), allocatable, target :: farg1_chars class(TpetraMultiVector), intent(in) :: x + type(SwigArrayWrapper) :: farg1 type(SwigClassWrapper) :: farg2 @@ -11547,6 +12349,7 @@ function new_TpetraWriter() & result(self) use, intrinsic :: ISO_C_BINDING type(TpetraWriter) :: self + type(SwigClassWrapper) :: fresult fresult = swigc_new_TpetraWriter() @@ -11556,13 +12359,14 @@ function new_TpetraWriter() & subroutine delete_TpetraWriter(self) use, intrinsic :: ISO_C_BINDING class(TpetraWriter), intent(inout) :: self + type(SwigClassWrapper) :: farg1 farg1 = self%swigdata if (self%swigdata%mem == SWIG_OWN) then call swigc_delete_TpetraWriter(farg1) end if -self%swigdata%ptr = C_NULL_PTR +self%swigdata%cptr = C_NULL_PTR self%swigdata%mem = SWIG_NULL end subroutine @@ -11575,14 +12379,18 @@ subroutine swigf_assignment_TpetraWriter(self, other) subroutine TpetraMatrixMatrixMultiply__SWIG_0(a, transposea, b, transposeb, c, call_fillcomplete_on_result, label, params) use, intrinsic :: ISO_C_BINDING class(TpetraCrsMatrix), intent(in) :: a + logical(C_BOOL), intent(in) :: transposea class(TpetraCrsMatrix), intent(in) :: b + logical(C_BOOL), intent(in) :: transposeb class(TpetraCrsMatrix), intent(inout) :: c + logical(C_BOOL), intent(in) :: call_fillcomplete_on_result character(kind=C_CHAR, len=*), target :: label character(kind=C_CHAR), dimension(:), allocatable, target :: farg7_chars class(ParameterList), intent(in) :: params + type(SwigClassWrapper) :: farg1 logical(C_BOOL) :: farg2 type(SwigClassWrapper) :: farg3 @@ -11606,13 +12414,17 @@ subroutine TpetraMatrixMatrixMultiply__SWIG_0(a, transposea, b, transposeb, c, c subroutine TpetraMatrixMatrixMultiply__SWIG_1(a, transposea, b, transposeb, c, call_fillcomplete_on_result, label) use, intrinsic :: ISO_C_BINDING class(TpetraCrsMatrix), intent(in) :: a + logical(C_BOOL), intent(in) :: transposea class(TpetraCrsMatrix), intent(in) :: b + logical(C_BOOL), intent(in) :: transposeb class(TpetraCrsMatrix), intent(inout) :: c + logical(C_BOOL), intent(in) :: call_fillcomplete_on_result character(kind=C_CHAR, len=*), target :: label character(kind=C_CHAR), dimension(:), allocatable, target :: farg7_chars + type(SwigClassWrapper) :: farg1 logical(C_BOOL) :: farg2 type(SwigClassWrapper) :: farg3 @@ -11634,11 +12446,15 @@ subroutine TpetraMatrixMatrixMultiply__SWIG_1(a, transposea, b, transposeb, c, c subroutine TpetraMatrixMatrixMultiply__SWIG_2(a, transposea, b, transposeb, c, call_fillcomplete_on_result) use, intrinsic :: ISO_C_BINDING class(TpetraCrsMatrix), intent(in) :: a + logical(C_BOOL), intent(in) :: transposea class(TpetraCrsMatrix), intent(in) :: b + logical(C_BOOL), intent(in) :: transposeb class(TpetraCrsMatrix), intent(inout) :: c + logical(C_BOOL), intent(in) :: call_fillcomplete_on_result + type(SwigClassWrapper) :: farg1 logical(C_BOOL) :: farg2 type(SwigClassWrapper) :: farg3 @@ -11658,10 +12474,13 @@ subroutine TpetraMatrixMatrixMultiply__SWIG_2(a, transposea, b, transposeb, c, c subroutine TpetraMatrixMatrixMultiply__SWIG_3(a, transposea, b, transposeb, c) use, intrinsic :: ISO_C_BINDING class(TpetraCrsMatrix), intent(in) :: a + logical(C_BOOL), intent(in) :: transposea class(TpetraCrsMatrix), intent(in) :: b + logical(C_BOOL), intent(in) :: transposeb class(TpetraCrsMatrix), intent(inout) :: c + type(SwigClassWrapper) :: farg1 logical(C_BOOL) :: farg2 type(SwigClassWrapper) :: farg3 @@ -11679,10 +12498,13 @@ subroutine TpetraMatrixMatrixMultiply__SWIG_3(a, transposea, b, transposeb, c) subroutine TpetraMatrixMatrixAdd__SWIG_0(a, transposea, scalara, b, scalarb) use, intrinsic :: ISO_C_BINDING class(TpetraCrsMatrix), intent(in) :: a + logical(C_BOOL), intent(in) :: transposea real(C_DOUBLE), intent(in) :: scalara class(TpetraCrsMatrix), intent(inout) :: b + real(C_DOUBLE), intent(in) :: scalarb + type(SwigClassWrapper) :: farg1 logical(C_BOOL) :: farg2 real(C_DOUBLE) :: farg3 @@ -11700,12 +12522,15 @@ subroutine TpetraMatrixMatrixAdd__SWIG_0(a, transposea, scalara, b, scalarb) subroutine TpetraMatrixMatrixAdd__SWIG_1(a, transposea, scalara, b, transposeb, scalarb, c) use, intrinsic :: ISO_C_BINDING class(TpetraCrsMatrix), intent(in) :: a + logical(C_BOOL), intent(in) :: transposea real(C_DOUBLE), intent(in) :: scalara class(TpetraCrsMatrix), intent(in) :: b + logical(C_BOOL), intent(in) :: transposeb real(C_DOUBLE), intent(in) :: scalarb class(TpetraCrsMatrix), intent(inout) :: c + type(SwigClassWrapper) :: farg1 logical(C_BOOL) :: farg2 real(C_DOUBLE) :: farg3 diff --git a/src/tpetra/src/fortpetra.i b/src/tpetra/src/fortpetra.i index ed3f2c2d..a639a0ed 100644 --- a/src/tpetra/src/fortpetra.i +++ b/src/tpetra/src/fortpetra.i @@ -32,11 +32,11 @@ typedef char Packet; %} // FIXME: Restore previous bool behaviour -FORT_FUND_TYPEMAP(bool, "logical(C_BOOL)") +FORT_FUND_TYPEMAP(bool, logical(C_BOOL)) // NOTE: with the latest SWIG, these will *not* show up in downstream // %imported modules even if %insert is replaced with %fragment. -%insert("fmodule") { +%insert("fuse") { use, intrinsic :: iso_c_binding, only : & c_bool, & c_int, & @@ -54,7 +54,7 @@ FORT_FUND_TYPEMAP(bool, "logical(C_BOOL)") mag_type => c_double, & norm_type => c_double } -%insert("fpublic") { +%insert("fdecl") { public :: scalar_type public :: local_ordinal_type public :: global_ordinal_type diff --git a/src/tpetra/src/fortpetraFORTRAN_wrap.cxx b/src/tpetra/src/fortpetraFORTRAN_wrap.cxx index a6faaf1f..b88a5aef 100644 --- a/src/tpetra/src/fortpetraFORTRAN_wrap.cxx +++ b/src/tpetra/src/fortpetraFORTRAN_wrap.cxx @@ -191,7 +191,7 @@ template T SwigValueInit() { #define SWIG_exception_impl(DECL, CODE, MSG, RETURNNULL) \ - { throw std::logic_error("In " DECL ": " MSG); RETURNNULL; } + { throw std::logic_error("In " DECL ": " MSG); } extern "C" { @@ -291,7 +291,7 @@ typedef char Packet; enum SwigMemState { - SWIG_NULL = 0, + SWIG_NULL, SWIG_OWN, SWIG_MOVE, SWIG_REF, @@ -300,14 +300,14 @@ enum SwigMemState { struct SwigClassWrapper { - void* ptr; + void* cptr; SwigMemState mem; }; SWIGINTERN SwigClassWrapper SwigClassWrapper_uninitialized() { SwigClassWrapper result; - result.ptr = NULL; + result.cptr = NULL; result.mem = SWIG_NULL; return result; } @@ -515,27 +515,28 @@ struct AssignmentTraits { template SWIGINTERN void SWIG_assign_impl(SwigClassWrapper* self, SwigClassWrapper* other) { typedef swig::AssignmentTraits Traits_t; - T1* pself = static_cast(self->ptr); - T2* pother = static_cast(other->ptr); + T1* pself = static_cast(self->cptr); + T2* pother = static_cast(other->cptr); switch (self->mem) { case SWIG_NULL: /* LHS is unassigned */ switch (other->mem) { - case SWIG_NULL: /* null op */ break; + case SWIG_NULL: /* null op */ + break; case SWIG_MOVE: /* capture pointer from RHS */ - self->ptr = other->ptr; - other->ptr = NULL; + self->cptr = other->cptr; + other->cptr = NULL; self->mem = SWIG_OWN; other->mem = SWIG_NULL; break; case SWIG_OWN: /* copy from RHS */ - self->ptr = Traits_t::copy_construct(pother); + self->cptr = Traits_t::copy_construct(pother); self->mem = SWIG_OWN; break; case SWIG_REF: /* pointer to RHS */ case SWIG_CREF: - self->ptr = other->ptr; + self->cptr = other->cptr; self->mem = other->mem; break; } @@ -546,14 +547,14 @@ SWIGINTERN void SWIG_assign_impl(SwigClassWrapper* self, SwigClassWrapper* other case SWIG_NULL: /* Delete LHS */ Traits_t::destruct(pself); - self->ptr = NULL; + self->cptr = NULL; self->mem = SWIG_NULL; break; case SWIG_MOVE: /* Move RHS into LHS; delete RHS */ Traits_t::move_assign(pself, pother); Traits_t::destruct(pother); - other->ptr = NULL; + other->cptr = NULL; other->mem = SWIG_NULL; break; case SWIG_OWN: @@ -574,7 +575,7 @@ SWIGINTERN void SWIG_assign_impl(SwigClassWrapper* self, SwigClassWrapper* other switch (other->mem) { case SWIG_NULL: /* Remove LHS reference */ - self->ptr = NULL; + self->cptr = NULL; self->mem = SWIG_NULL; break; case SWIG_MOVE: @@ -582,7 +583,7 @@ SWIGINTERN void SWIG_assign_impl(SwigClassWrapper* self, SwigClassWrapper* other * same. */ Traits_t::move_assign(pself, pother); Traits_t::destruct(pother); - other->ptr = NULL; + other->cptr = NULL; other->mem = SWIG_NULL; break; case SWIG_OWN: @@ -597,8 +598,9 @@ SWIGINTERN void SWIG_assign_impl(SwigClassWrapper* self, SwigClassWrapper* other switch (other->mem) { case SWIG_NULL: /* Remove LHS reference */ - self->ptr = NULL; + self->cptr = NULL; self->mem = SWIG_NULL; + break; default: SWIG_exception_impl("assignment", SWIG_RuntimeError, "Cannot assign to a const reference", return); @@ -742,12 +744,12 @@ SwigClassWrapper swigd_ForTpetraOperator_getRangeMap( Teuchos::RCP tempthis( const_cast(this) SWIG_NO_NULL_DELETER_0); SwigClassWrapper self; - self.ptr = &tempthis; + self.cptr = &tempthis; self.mem = SWIG_CREF; // since this function is const SwigClassWrapper fresult = swigd_ForTpetraOperator_getDomainMap(&self); - Teuchos::RCP* smartresult = static_cast< Teuchos::RCP* >(fresult.ptr); + Teuchos::RCP* smartresult = static_cast< Teuchos::RCP* >(fresult.cptr); return *smartresult; } @@ -756,12 +758,12 @@ SwigClassWrapper swigd_ForTpetraOperator_getRangeMap( Teuchos::RCP tempthis( const_cast(this) SWIG_NO_NULL_DELETER_0); SwigClassWrapper self; - self.ptr = &tempthis; + self.cptr = &tempthis; self.mem = SWIG_CREF; // since this function is const SwigClassWrapper fresult = swigd_ForTpetraOperator_getRangeMap(&self); - Teuchos::RCP* smartresult = static_cast< Teuchos::RCP* >(fresult.ptr); + Teuchos::RCP* smartresult = static_cast< Teuchos::RCP* >(fresult.cptr); return *smartresult; } @@ -772,20 +774,20 @@ SwigClassWrapper swigd_ForTpetraOperator_getRangeMap( Teuchos::RCP tempthis( const_cast(this) SWIG_NO_NULL_DELETER_0); SwigClassWrapper self; - self.ptr = &tempthis; + self.cptr = &tempthis; self.mem = SWIG_CREF; // since this function is const /* convert X -> class wrapper */ Teuchos::RCP > temprcp1(&X SWIG_NO_NULL_DELETER_0); SwigClassWrapper farg1; - farg1.ptr = &temprcp1; + farg1.cptr = &temprcp1; farg1.mem = SWIG_CREF; // X is const Teuchos::RCP< Tpetra::MultiVector > temprcp2(&Y SWIG_NO_NULL_DELETER_0); SwigClassWrapper farg2; - farg2.ptr = &temprcp2; + farg2.cptr = &temprcp2; farg2.mem = SWIG_REF; // Y is mutable /* convert scalars to wrappers */ @@ -1066,6 +1068,16 @@ SWIGINTERN void Tpetra_MatrixMarket_Writer_Sl_CMT_Sg__writeDenseFile__SWIG_1(std #ifdef __cplusplus extern "C" { #endif +SWIGEXPORT SWIGEXTERN int const _wrap_TPETRA_THROWS_EFFICIENCY_WARNINGS = static_cast< int >(0); + +SWIGEXPORT SWIGEXTERN int const _wrap_TPETRA_PRINTS_EFFICIENCY_WARNINGS = static_cast< int >(0); + +SWIGEXPORT SWIGEXTERN int const _wrap_TPETRA_THROWS_ABUSE_WARNINGS = static_cast< int >(0); + +SWIGEXPORT SWIGEXTERN int const _wrap_TPETRA_PRINTS_ABUSE_WARNINGS = static_cast< int >(0); + +SWIGEXPORT SWIGEXTERN int const _wrap_TPETRA_USE_KOKKOS_DISTOBJECT = static_cast< int >(0); + SWIGEXPORT void _wrap_setCombineModeParameter(SwigClassWrapper const *farg1, SwigArrayWrapper *farg2) { Teuchos::ParameterList *arg1 = 0 ; std::string *arg2 = 0 ; @@ -1073,8 +1085,8 @@ SWIGEXPORT void _wrap_setCombineModeParameter(SwigClassWrapper const *farg1, Swi std::string tempstr2 ; SWIG_check_sp_nonnull(farg1, "Teuchos::ParameterList *", "ParameterList", "Tpetra::setCombineModeParameter(Teuchos::ParameterList &,std::string const &)", return ) - smartarg1 = static_cast< Teuchos::RCP< Teuchos::ParameterList >* >(farg1->ptr); - arg1 = smartarg1->get(); + smartarg1 = static_cast< Teuchos::RCP< Teuchos::ParameterList >* >(farg1->cptr); + arg1 = const_cast< Teuchos::ParameterList* >(smartarg1->get()); tempstr2 = std::string(static_cast(farg2->data), farg2->size); arg2 = &tempstr2; { @@ -1108,7 +1120,7 @@ SWIGEXPORT SwigArrayWrapper _wrap_combineModeToString(int const *farg1) { SwigArrayWrapper fresult ; Tpetra::CombineMode arg1 ; std::string result; - + arg1 = static_cast< Tpetra::CombineMode >(*farg1); { // Make sure no unhandled exceptions exist before performing a new action @@ -1171,7 +1183,7 @@ SWIGEXPORT SwigClassWrapper _wrap_new_TpetraMap__SWIG_0() { SWIG_exception_impl("Tpetra::Map< LO,GO,NO >::Map()", SWIG_UnknownError, "An unknown exception occurred", return SwigClassWrapper_uninitialized()); } } - fresult.ptr = result ? new Teuchos::RCP< Tpetra::Map >(result SWIG_NO_NULL_DELETER_1) : NULL; + fresult.cptr = result ? new Teuchos::RCP< Tpetra::Map >(result SWIG_NO_NULL_DELETER_1) : NULL; fresult.mem = SWIG_MOVE; return fresult; } @@ -1181,8 +1193,8 @@ SWIGEXPORT void _wrap_delete_TpetraMap(SwigClassWrapper const *farg1) { Tpetra::Map< LO,GO,NO > *arg1 = (Tpetra::Map< LO,GO,NO > *) 0 ; Teuchos::RCP< Tpetra::Map< LO,GO,NO > > *smartarg1 ; - smartarg1 = static_cast< Teuchos::RCP< Tpetra::Map >* >(farg1->ptr); - arg1 = smartarg1 ? smartarg1->get() : NULL; + smartarg1 = static_cast< Teuchos::RCP< Tpetra::Map >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::Map* >(smartarg1->get()) : NULL; { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::Map< LO,GO,NO >::~Map()");; @@ -1216,8 +1228,8 @@ SWIGEXPORT bool _wrap_TpetraMap_isOneToOne(SwigClassWrapper const *farg1) { Teuchos::RCP< Tpetra::Map< LO,GO,NO > const > *smartarg1 ; bool result; - smartarg1 = static_cast< Teuchos::RCP >* >(farg1->ptr); - arg1 = smartarg1 ? const_cast*>(smartarg1->get()) : NULL; + smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::Map* >(smartarg1->get()) : NULL; { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::Map< LO,GO,NO >::isOneToOne() const");; @@ -1241,19 +1253,19 @@ SWIGEXPORT bool _wrap_TpetraMap_isOneToOne(SwigClassWrapper const *farg1) { SWIG_exception_impl("Tpetra::Map< LO,GO,NO >::isOneToOne() const", SWIG_UnknownError, "An unknown exception occurred", return 0); } } - fresult = result; + fresult = static_cast< bool >(result); return fresult; } -SWIGEXPORT unsigned long _wrap_TpetraMap_getGlobalNumElements(SwigClassWrapper const *farg1) { - unsigned long fresult ; +SWIGEXPORT long _wrap_TpetraMap_getGlobalNumElements(SwigClassWrapper const *farg1) { + long fresult ; Tpetra::Map< LO,GO,NO > *arg1 = (Tpetra::Map< LO,GO,NO > *) 0 ; Teuchos::RCP< Tpetra::Map< LO,GO,NO > const > *smartarg1 ; Tpetra::global_size_t result; - smartarg1 = static_cast< Teuchos::RCP >* >(farg1->ptr); - arg1 = smartarg1 ? const_cast*>(smartarg1->get()) : NULL; + smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::Map* >(smartarg1->get()) : NULL; { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::Map< LO,GO,NO >::getGlobalNumElements() const");; @@ -1277,7 +1289,7 @@ SWIGEXPORT unsigned long _wrap_TpetraMap_getGlobalNumElements(SwigClassWrapper c SWIG_exception_impl("Tpetra::Map< LO,GO,NO >::getGlobalNumElements() const", SWIG_UnknownError, "An unknown exception occurred", return 0); } } - fresult = result; + fresult = static_cast< Tpetra::global_size_t >(result); return fresult; } @@ -1288,8 +1300,8 @@ SWIGEXPORT size_t _wrap_TpetraMap_getNodeNumElements(SwigClassWrapper const *far Teuchos::RCP< Tpetra::Map< LO,GO,NO > const > *smartarg1 ; size_t result; - smartarg1 = static_cast< Teuchos::RCP >* >(farg1->ptr); - arg1 = smartarg1 ? const_cast*>(smartarg1->get()) : NULL; + smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::Map* >(smartarg1->get()) : NULL; { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::Map< LO,GO,NO >::getNodeNumElements() const");; @@ -1313,7 +1325,7 @@ SWIGEXPORT size_t _wrap_TpetraMap_getNodeNumElements(SwigClassWrapper const *far SWIG_exception_impl("Tpetra::Map< LO,GO,NO >::getNodeNumElements() const", SWIG_UnknownError, "An unknown exception occurred", return 0); } } - fresult = result; + fresult = static_cast< size_t >(result); return fresult; } @@ -1324,8 +1336,8 @@ SWIGEXPORT int _wrap_TpetraMap_getMinLocalIndex(SwigClassWrapper const *farg1) { Teuchos::RCP< Tpetra::Map< LO,GO,NO > const > *smartarg1 ; int result; - smartarg1 = static_cast< Teuchos::RCP >* >(farg1->ptr); - arg1 = smartarg1 ? const_cast*>(smartarg1->get()) : NULL; + smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::Map* >(smartarg1->get()) : NULL; { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::Map< LO,GO,NO >::getMinLocalIndex() const");; @@ -1360,8 +1372,8 @@ SWIGEXPORT int _wrap_TpetraMap_getMaxLocalIndex(SwigClassWrapper const *farg1) { Teuchos::RCP< Tpetra::Map< LO,GO,NO > const > *smartarg1 ; int result; - smartarg1 = static_cast< Teuchos::RCP >* >(farg1->ptr); - arg1 = smartarg1 ? const_cast*>(smartarg1->get()) : NULL; + smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::Map* >(smartarg1->get()) : NULL; { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::Map< LO,GO,NO >::getMaxLocalIndex() const");; @@ -1396,8 +1408,8 @@ SWIGEXPORT long long _wrap_TpetraMap_getMinGlobalIndex(SwigClassWrapper const *f Teuchos::RCP< Tpetra::Map< LO,GO,NO > const > *smartarg1 ; long long result; - smartarg1 = static_cast< Teuchos::RCP >* >(farg1->ptr); - arg1 = smartarg1 ? const_cast*>(smartarg1->get()) : NULL; + smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::Map* >(smartarg1->get()) : NULL; { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::Map< LO,GO,NO >::getMinGlobalIndex() const");; @@ -1421,7 +1433,7 @@ SWIGEXPORT long long _wrap_TpetraMap_getMinGlobalIndex(SwigClassWrapper const *f SWIG_exception_impl("Tpetra::Map< LO,GO,NO >::getMinGlobalIndex() const", SWIG_UnknownError, "An unknown exception occurred", return 0); } } - fresult = result; + fresult = static_cast< long long >(result); return fresult; } @@ -1432,8 +1444,8 @@ SWIGEXPORT long long _wrap_TpetraMap_getMaxGlobalIndex(SwigClassWrapper const *f Teuchos::RCP< Tpetra::Map< LO,GO,NO > const > *smartarg1 ; long long result; - smartarg1 = static_cast< Teuchos::RCP >* >(farg1->ptr); - arg1 = smartarg1 ? const_cast*>(smartarg1->get()) : NULL; + smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::Map* >(smartarg1->get()) : NULL; { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::Map< LO,GO,NO >::getMaxGlobalIndex() const");; @@ -1457,7 +1469,7 @@ SWIGEXPORT long long _wrap_TpetraMap_getMaxGlobalIndex(SwigClassWrapper const *f SWIG_exception_impl("Tpetra::Map< LO,GO,NO >::getMaxGlobalIndex() const", SWIG_UnknownError, "An unknown exception occurred", return 0); } } - fresult = result; + fresult = static_cast< long long >(result); return fresult; } @@ -1468,8 +1480,8 @@ SWIGEXPORT long long _wrap_TpetraMap_getMinAllGlobalIndex(SwigClassWrapper const Teuchos::RCP< Tpetra::Map< LO,GO,NO > const > *smartarg1 ; long long result; - smartarg1 = static_cast< Teuchos::RCP >* >(farg1->ptr); - arg1 = smartarg1 ? const_cast*>(smartarg1->get()) : NULL; + smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::Map* >(smartarg1->get()) : NULL; { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::Map< LO,GO,NO >::getMinAllGlobalIndex() const");; @@ -1493,7 +1505,7 @@ SWIGEXPORT long long _wrap_TpetraMap_getMinAllGlobalIndex(SwigClassWrapper const SWIG_exception_impl("Tpetra::Map< LO,GO,NO >::getMinAllGlobalIndex() const", SWIG_UnknownError, "An unknown exception occurred", return 0); } } - fresult = result; + fresult = static_cast< long long >(result); return fresult; } @@ -1504,8 +1516,8 @@ SWIGEXPORT long long _wrap_TpetraMap_getMaxAllGlobalIndex(SwigClassWrapper const Teuchos::RCP< Tpetra::Map< LO,GO,NO > const > *smartarg1 ; long long result; - smartarg1 = static_cast< Teuchos::RCP >* >(farg1->ptr); - arg1 = smartarg1 ? const_cast*>(smartarg1->get()) : NULL; + smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::Map* >(smartarg1->get()) : NULL; { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::Map< LO,GO,NO >::getMaxAllGlobalIndex() const");; @@ -1529,7 +1541,7 @@ SWIGEXPORT long long _wrap_TpetraMap_getMaxAllGlobalIndex(SwigClassWrapper const SWIG_exception_impl("Tpetra::Map< LO,GO,NO >::getMaxAllGlobalIndex() const", SWIG_UnknownError, "An unknown exception occurred", return 0); } } - fresult = result; + fresult = static_cast< long long >(result); return fresult; } @@ -1541,9 +1553,9 @@ SWIGEXPORT int _wrap_TpetraMap_getLocalElement(SwigClassWrapper const *farg1, lo Teuchos::RCP< Tpetra::Map< LO,GO,NO > const > *smartarg1 ; int result; - smartarg1 = static_cast< Teuchos::RCP >* >(farg1->ptr); - arg1 = smartarg1 ? const_cast*>(smartarg1->get()) : NULL; - arg2 = *farg2; + smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::Map* >(smartarg1->get()) : NULL; + arg2 = static_cast< long long >(*farg2); { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::Map< LO,GO,NO >::getLocalElement(long long) const");; @@ -1579,8 +1591,8 @@ SWIGEXPORT long long _wrap_TpetraMap_getGlobalElement(SwigClassWrapper const *fa Teuchos::RCP< Tpetra::Map< LO,GO,NO > const > *smartarg1 ; long long result; - smartarg1 = static_cast< Teuchos::RCP >* >(farg1->ptr); - arg1 = smartarg1 ? const_cast*>(smartarg1->get()) : NULL; + smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::Map* >(smartarg1->get()) : NULL; arg2 = *farg2 - 1; { // Make sure no unhandled exceptions exist before performing a new action @@ -1605,7 +1617,7 @@ SWIGEXPORT long long _wrap_TpetraMap_getGlobalElement(SwigClassWrapper const *fa SWIG_exception_impl("Tpetra::Map< LO,GO,NO >::getGlobalElement(int) const", SWIG_UnknownError, "An unknown exception occurred", return 0); } } - fresult = result; + fresult = static_cast< long long >(result); return fresult; } @@ -1617,8 +1629,8 @@ SWIGEXPORT bool _wrap_TpetraMap_isNodeLocalElement(SwigClassWrapper const *farg1 Teuchos::RCP< Tpetra::Map< LO,GO,NO > const > *smartarg1 ; bool result; - smartarg1 = static_cast< Teuchos::RCP >* >(farg1->ptr); - arg1 = smartarg1 ? const_cast*>(smartarg1->get()) : NULL; + smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::Map* >(smartarg1->get()) : NULL; arg2 = *farg2 - 1; { // Make sure no unhandled exceptions exist before performing a new action @@ -1643,7 +1655,7 @@ SWIGEXPORT bool _wrap_TpetraMap_isNodeLocalElement(SwigClassWrapper const *farg1 SWIG_exception_impl("Tpetra::Map< LO,GO,NO >::isNodeLocalElement(int) const", SWIG_UnknownError, "An unknown exception occurred", return 0); } } - fresult = result; + fresult = static_cast< bool >(result); return fresult; } @@ -1655,9 +1667,9 @@ SWIGEXPORT bool _wrap_TpetraMap_isNodeGlobalElement(SwigClassWrapper const *farg Teuchos::RCP< Tpetra::Map< LO,GO,NO > const > *smartarg1 ; bool result; - smartarg1 = static_cast< Teuchos::RCP >* >(farg1->ptr); - arg1 = smartarg1 ? const_cast*>(smartarg1->get()) : NULL; - arg2 = *farg2; + smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::Map* >(smartarg1->get()) : NULL; + arg2 = static_cast< long long >(*farg2); { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::Map< LO,GO,NO >::isNodeGlobalElement(long long) const");; @@ -1681,7 +1693,7 @@ SWIGEXPORT bool _wrap_TpetraMap_isNodeGlobalElement(SwigClassWrapper const *farg SWIG_exception_impl("Tpetra::Map< LO,GO,NO >::isNodeGlobalElement(long long) const", SWIG_UnknownError, "An unknown exception occurred", return 0); } } - fresult = result; + fresult = static_cast< bool >(result); return fresult; } @@ -1692,8 +1704,8 @@ SWIGEXPORT bool _wrap_TpetraMap_isUniform(SwigClassWrapper const *farg1) { Teuchos::RCP< Tpetra::Map< LO,GO,NO > const > *smartarg1 ; bool result; - smartarg1 = static_cast< Teuchos::RCP >* >(farg1->ptr); - arg1 = smartarg1 ? const_cast*>(smartarg1->get()) : NULL; + smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::Map* >(smartarg1->get()) : NULL; { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::Map< LO,GO,NO >::isUniform() const");; @@ -1717,7 +1729,7 @@ SWIGEXPORT bool _wrap_TpetraMap_isUniform(SwigClassWrapper const *farg1) { SWIG_exception_impl("Tpetra::Map< LO,GO,NO >::isUniform() const", SWIG_UnknownError, "An unknown exception occurred", return 0); } } - fresult = result; + fresult = static_cast< bool >(result); return fresult; } @@ -1728,8 +1740,8 @@ SWIGEXPORT bool _wrap_TpetraMap_isContiguous(SwigClassWrapper const *farg1) { Teuchos::RCP< Tpetra::Map< LO,GO,NO > const > *smartarg1 ; bool result; - smartarg1 = static_cast< Teuchos::RCP >* >(farg1->ptr); - arg1 = smartarg1 ? const_cast*>(smartarg1->get()) : NULL; + smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::Map* >(smartarg1->get()) : NULL; { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::Map< LO,GO,NO >::isContiguous() const");; @@ -1753,7 +1765,7 @@ SWIGEXPORT bool _wrap_TpetraMap_isContiguous(SwigClassWrapper const *farg1) { SWIG_exception_impl("Tpetra::Map< LO,GO,NO >::isContiguous() const", SWIG_UnknownError, "An unknown exception occurred", return 0); } } - fresult = result; + fresult = static_cast< bool >(result); return fresult; } @@ -1764,8 +1776,8 @@ SWIGEXPORT bool _wrap_TpetraMap_isDistributed(SwigClassWrapper const *farg1) { Teuchos::RCP< Tpetra::Map< LO,GO,NO > const > *smartarg1 ; bool result; - smartarg1 = static_cast< Teuchos::RCP >* >(farg1->ptr); - arg1 = smartarg1 ? const_cast*>(smartarg1->get()) : NULL; + smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::Map* >(smartarg1->get()) : NULL; { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::Map< LO,GO,NO >::isDistributed() const");; @@ -1789,7 +1801,7 @@ SWIGEXPORT bool _wrap_TpetraMap_isDistributed(SwigClassWrapper const *farg1) { SWIG_exception_impl("Tpetra::Map< LO,GO,NO >::isDistributed() const", SWIG_UnknownError, "An unknown exception occurred", return 0); } } - fresult = result; + fresult = static_cast< bool >(result); return fresult; } @@ -1802,11 +1814,11 @@ SWIGEXPORT bool _wrap_TpetraMap_isCompatible(SwigClassWrapper const *farg1, Swig Teuchos::RCP< Tpetra::Map< LO,GO,NO > const > *smartarg2 ; bool result; - smartarg1 = static_cast< Teuchos::RCP >* >(farg1->ptr); - arg1 = smartarg1 ? const_cast*>(smartarg1->get()) : NULL; + smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::Map* >(smartarg1->get()) : NULL; SWIG_check_sp_nonnull(farg2, "Tpetra::Map< int,long long,Kokkos::Compat::KokkosSerialWrapperNode > *", "TpetraMap", "Tpetra::Map< LO,GO,NO >::isCompatible(Tpetra::Map< int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &) const", return 0) - smartarg2 = static_cast< Teuchos::RCP >* >(farg2->ptr); - arg2 = const_cast*>(smartarg2->get()); + smartarg2 = static_cast< Teuchos::RCP >* >(farg2->cptr); + arg2 = const_cast< Tpetra::Map* >(smartarg2->get()); { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::Map< LO,GO,NO >::isCompatible(Tpetra::Map< int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &) const");; @@ -1830,7 +1842,7 @@ SWIGEXPORT bool _wrap_TpetraMap_isCompatible(SwigClassWrapper const *farg1, Swig SWIG_exception_impl("Tpetra::Map< LO,GO,NO >::isCompatible(Tpetra::Map< int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &) const", SWIG_UnknownError, "An unknown exception occurred", return 0); } } - fresult = result; + fresult = static_cast< bool >(result); return fresult; } @@ -1843,11 +1855,11 @@ SWIGEXPORT bool _wrap_TpetraMap_isSameAs(SwigClassWrapper const *farg1, SwigClas Teuchos::RCP< Tpetra::Map< LO,GO,NO > const > *smartarg2 ; bool result; - smartarg1 = static_cast< Teuchos::RCP >* >(farg1->ptr); - arg1 = smartarg1 ? const_cast*>(smartarg1->get()) : NULL; + smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::Map* >(smartarg1->get()) : NULL; SWIG_check_sp_nonnull(farg2, "Tpetra::Map< int,long long,Kokkos::Compat::KokkosSerialWrapperNode > *", "TpetraMap", "Tpetra::Map< LO,GO,NO >::isSameAs(Tpetra::Map< int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &) const", return 0) - smartarg2 = static_cast< Teuchos::RCP >* >(farg2->ptr); - arg2 = const_cast*>(smartarg2->get()); + smartarg2 = static_cast< Teuchos::RCP >* >(farg2->cptr); + arg2 = const_cast< Tpetra::Map* >(smartarg2->get()); { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::Map< LO,GO,NO >::isSameAs(Tpetra::Map< int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &) const");; @@ -1871,7 +1883,7 @@ SWIGEXPORT bool _wrap_TpetraMap_isSameAs(SwigClassWrapper const *farg1, SwigClas SWIG_exception_impl("Tpetra::Map< LO,GO,NO >::isSameAs(Tpetra::Map< int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &) const", SWIG_UnknownError, "An unknown exception occurred", return 0); } } - fresult = result; + fresult = static_cast< bool >(result); return fresult; } @@ -1884,11 +1896,11 @@ SWIGEXPORT bool _wrap_TpetraMap_locallySameAs(SwigClassWrapper const *farg1, Swi Teuchos::RCP< Tpetra::Map< LO,GO,NO > const > *smartarg2 ; bool result; - smartarg1 = static_cast< Teuchos::RCP >* >(farg1->ptr); - arg1 = smartarg1 ? const_cast*>(smartarg1->get()) : NULL; + smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::Map* >(smartarg1->get()) : NULL; SWIG_check_sp_nonnull(farg2, "Tpetra::Map< int,long long,Tpetra::Map< LO,GO,NO >::node_type > *", "TpetraMap", "Tpetra::Map< LO,GO,NO >::locallySameAs(Tpetra::Map< int,long long,Tpetra::Map< LO,GO,NO >::node_type > const &) const", return 0) - smartarg2 = static_cast< Teuchos::RCP >* >(farg2->ptr); - arg2 = const_cast*>(smartarg2->get()); + smartarg2 = static_cast< Teuchos::RCP >* >(farg2->cptr); + arg2 = const_cast< Tpetra::Map* >(smartarg2->get()); { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::Map< LO,GO,NO >::locallySameAs(Tpetra::Map< int,long long,Tpetra::Map< LO,GO,NO >::node_type > const &) const");; @@ -1912,7 +1924,7 @@ SWIGEXPORT bool _wrap_TpetraMap_locallySameAs(SwigClassWrapper const *farg1, Swi SWIG_exception_impl("Tpetra::Map< LO,GO,NO >::locallySameAs(Tpetra::Map< int,long long,Tpetra::Map< LO,GO,NO >::node_type > const &) const", SWIG_UnknownError, "An unknown exception occurred", return 0); } } - fresult = result; + fresult = static_cast< bool >(result); return fresult; } @@ -1924,12 +1936,12 @@ SWIGEXPORT bool _wrap_TpetraMap_isLocallyFitted(SwigClassWrapper const *farg1, S Teuchos::RCP< Tpetra::Map< LO,GO,NO > const > *smartarg1 ; Teuchos::RCP< Tpetra::Map< LO,GO,NO > const > *smartarg2 ; bool result; - - smartarg1 = static_cast< Teuchos::RCP >* >(farg1->ptr); - arg1 = smartarg1 ? const_cast*>(smartarg1->get()) : NULL; + + smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::Map* >(smartarg1->get()) : NULL; SWIG_check_sp_nonnull(farg2, "Tpetra::Map< int,long long,Kokkos::Compat::KokkosSerialWrapperNode > *", "TpetraMap", "Tpetra::Map< LO,GO,NO >::isLocallyFitted(Tpetra::Map< int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &) const", return 0) - smartarg2 = static_cast< Teuchos::RCP >* >(farg2->ptr); - arg2 = const_cast*>(smartarg2->get()); + smartarg2 = static_cast< Teuchos::RCP >* >(farg2->cptr); + arg2 = const_cast< Tpetra::Map* >(smartarg2->get()); { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::Map< LO,GO,NO >::isLocallyFitted(Tpetra::Map< int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &) const");; @@ -1953,7 +1965,7 @@ SWIGEXPORT bool _wrap_TpetraMap_isLocallyFitted(SwigClassWrapper const *farg1, S SWIG_exception_impl("Tpetra::Map< LO,GO,NO >::isLocallyFitted(Tpetra::Map< int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &) const", SWIG_UnknownError, "An unknown exception occurred", return 0); } } - fresult = result; + fresult = static_cast< bool >(result); return fresult; } @@ -1964,8 +1976,8 @@ SWIGEXPORT SwigClassWrapper _wrap_TpetraMap_getComm(SwigClassWrapper const *farg Teuchos::RCP< Tpetra::Map< LO,GO,NO > const > *smartarg1 ; Teuchos::RCP< Teuchos::Comm< int > const > result; - smartarg1 = static_cast< Teuchos::RCP >* >(farg1->ptr); - arg1 = smartarg1 ? const_cast*>(smartarg1->get()) : NULL; + smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::Map* >(smartarg1->get()) : NULL; { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::Map< LO,GO,NO >::getComm() const");; @@ -1989,7 +2001,7 @@ SWIGEXPORT SwigClassWrapper _wrap_TpetraMap_getComm(SwigClassWrapper const *farg SWIG_exception_impl("Tpetra::Map< LO,GO,NO >::getComm() const", SWIG_UnknownError, "An unknown exception occurred", return SwigClassWrapper_uninitialized()); } } - fresult.ptr = (new Teuchos::RCP >(static_cast< const Teuchos::RCP >& >(result))); + fresult.cptr = (new Teuchos::RCP >(static_cast< const Teuchos::RCP >& >(result))); fresult.mem = SWIG_MOVE; return fresult; } @@ -2001,8 +2013,8 @@ SWIGEXPORT SwigArrayWrapper _wrap_TpetraMap_description(SwigClassWrapper const * Teuchos::RCP< Tpetra::Map< LO,GO,NO > const > *smartarg1 ; std::string result; - smartarg1 = static_cast< Teuchos::RCP >* >(farg1->ptr); - arg1 = smartarg1 ? const_cast*>(smartarg1->get()) : NULL; + smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::Map* >(smartarg1->get()) : NULL; { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::Map< LO,GO,NO >::description() const");; @@ -2043,8 +2055,8 @@ SWIGEXPORT SwigClassWrapper _wrap_TpetraMap_removeEmptyProcesses(SwigClassWrappe Teuchos::RCP< Tpetra::Map< LO,GO,NO > const > *smartarg1 ; Teuchos::RCP< Tpetra::Map< int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const > result; - smartarg1 = static_cast< Teuchos::RCP >* >(farg1->ptr); - arg1 = smartarg1 ? const_cast*>(smartarg1->get()) : NULL; + smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::Map* >(smartarg1->get()) : NULL; { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::Map< LO,GO,NO >::removeEmptyProcesses() const");; @@ -2068,7 +2080,7 @@ SWIGEXPORT SwigClassWrapper _wrap_TpetraMap_removeEmptyProcesses(SwigClassWrappe SWIG_exception_impl("Tpetra::Map< LO,GO,NO >::removeEmptyProcesses() const", SWIG_UnknownError, "An unknown exception occurred", return SwigClassWrapper_uninitialized()); } } - fresult.ptr = (new Teuchos::RCP >(static_cast< const Teuchos::RCP >& >(result))); + fresult.cptr = (new Teuchos::RCP >(static_cast< const Teuchos::RCP >& >(result))); fresult.mem = SWIG_MOVE; return fresult; } @@ -2082,9 +2094,9 @@ SWIGEXPORT SwigClassWrapper _wrap_TpetraMap_replaceCommWithSubset(SwigClassWrapp Teuchos::RCP< Teuchos::Comm< int > const > tempnull2 ; Teuchos::RCP< Tpetra::Map< int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const > result; - smartarg1 = static_cast< Teuchos::RCP >* >(farg1->ptr); - arg1 = smartarg1 ? const_cast*>(smartarg1->get()) : NULL; - arg2 = farg2->ptr ? static_cast< Teuchos::RCP< Teuchos::Comm< int > const > * >(farg2->ptr) : &tempnull2; + smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::Map* >(smartarg1->get()) : NULL; + arg2 = farg2->cptr ? static_cast< Teuchos::RCP< Teuchos::Comm< int > const > * >(farg2->cptr) : &tempnull2; { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::Map< LO,GO,NO >::replaceCommWithSubset(Teuchos::RCP< Teuchos::Comm< int > const > const &) const");; @@ -2108,13 +2120,13 @@ SWIGEXPORT SwigClassWrapper _wrap_TpetraMap_replaceCommWithSubset(SwigClassWrapp SWIG_exception_impl("Tpetra::Map< LO,GO,NO >::replaceCommWithSubset(Teuchos::RCP< Teuchos::Comm< int > const > const &) const", SWIG_UnknownError, "An unknown exception occurred", return SwigClassWrapper_uninitialized()); } } - fresult.ptr = (new Teuchos::RCP >(static_cast< const Teuchos::RCP >& >(result))); + fresult.cptr = (new Teuchos::RCP >(static_cast< const Teuchos::RCP >& >(result))); fresult.mem = SWIG_MOVE; return fresult; } -SWIGEXPORT SwigClassWrapper _wrap_new_TpetraMap__SWIG_1(unsigned long const *farg1, SwigClassWrapper const *farg2, int const *farg3) { +SWIGEXPORT SwigClassWrapper _wrap_new_TpetraMap__SWIG_1(long const *farg1, SwigClassWrapper const *farg2, int const *farg3) { SwigClassWrapper fresult ; Tpetra::global_size_t arg1 ; Teuchos::RCP< Teuchos::Comm< int > const > *arg2 = 0 ; @@ -2122,8 +2134,8 @@ SWIGEXPORT SwigClassWrapper _wrap_new_TpetraMap__SWIG_1(unsigned long const *far Teuchos::RCP< Teuchos::Comm< int > const > tempnull2 ; Tpetra::Map< LO,GO,NO > *result = 0 ; - arg1 = *farg1; - arg2 = farg2->ptr ? static_cast< Teuchos::RCP< Teuchos::Comm< int > const > * >(farg2->ptr) : &tempnull2; + arg1 = static_cast< Tpetra::global_size_t >(*farg1); + arg2 = farg2->cptr ? static_cast< Teuchos::RCP< Teuchos::Comm< int > const > * >(farg2->cptr) : &tempnull2; arg3 = static_cast< Tpetra::LocalGlobal >(*farg3); { // Make sure no unhandled exceptions exist before performing a new action @@ -2148,21 +2160,21 @@ SWIGEXPORT SwigClassWrapper _wrap_new_TpetraMap__SWIG_1(unsigned long const *far SWIG_exception_impl("Tpetra::Map< LO,GO,NO >::Map(Tpetra::global_size_t,Teuchos::RCP< Teuchos::Comm< int > const > const &,Tpetra::LocalGlobal)", SWIG_UnknownError, "An unknown exception occurred", return SwigClassWrapper_uninitialized()); } } - fresult.ptr = result ? new Teuchos::RCP< Tpetra::Map >(result SWIG_NO_NULL_DELETER_1) : NULL; + fresult.cptr = result ? new Teuchos::RCP< Tpetra::Map >(result SWIG_NO_NULL_DELETER_1) : NULL; fresult.mem = SWIG_MOVE; return fresult; } -SWIGEXPORT SwigClassWrapper _wrap_new_TpetraMap__SWIG_2(unsigned long const *farg1, SwigClassWrapper const *farg2) { +SWIGEXPORT SwigClassWrapper _wrap_new_TpetraMap__SWIG_2(long const *farg1, SwigClassWrapper const *farg2) { SwigClassWrapper fresult ; Tpetra::global_size_t arg1 ; Teuchos::RCP< Teuchos::Comm< int > const > *arg2 = 0 ; Teuchos::RCP< Teuchos::Comm< int > const > tempnull2 ; Tpetra::Map< LO,GO,NO > *result = 0 ; - arg1 = *farg1; - arg2 = farg2->ptr ? static_cast< Teuchos::RCP< Teuchos::Comm< int > const > * >(farg2->ptr) : &tempnull2; + arg1 = static_cast< Tpetra::global_size_t >(*farg1); + arg2 = farg2->cptr ? static_cast< Teuchos::RCP< Teuchos::Comm< int > const > * >(farg2->cptr) : &tempnull2; { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::Map< LO,GO,NO >::Map(Tpetra::global_size_t,Teuchos::RCP< Teuchos::Comm< int > const > const &)");; @@ -2186,13 +2198,13 @@ SWIGEXPORT SwigClassWrapper _wrap_new_TpetraMap__SWIG_2(unsigned long const *far SWIG_exception_impl("Tpetra::Map< LO,GO,NO >::Map(Tpetra::global_size_t,Teuchos::RCP< Teuchos::Comm< int > const > const &)", SWIG_UnknownError, "An unknown exception occurred", return SwigClassWrapper_uninitialized()); } } - fresult.ptr = result ? new Teuchos::RCP< Tpetra::Map >(result SWIG_NO_NULL_DELETER_1) : NULL; + fresult.cptr = result ? new Teuchos::RCP< Tpetra::Map >(result SWIG_NO_NULL_DELETER_1) : NULL; fresult.mem = SWIG_MOVE; return fresult; } -SWIGEXPORT SwigClassWrapper _wrap_new_TpetraMap__SWIG_3(unsigned long const *farg1, size_t const *farg2, SwigClassWrapper const *farg3) { +SWIGEXPORT SwigClassWrapper _wrap_new_TpetraMap__SWIG_3(long const *farg1, size_t const *farg2, SwigClassWrapper const *farg3) { SwigClassWrapper fresult ; Tpetra::global_size_t arg1 ; size_t arg2 ; @@ -2200,9 +2212,9 @@ SWIGEXPORT SwigClassWrapper _wrap_new_TpetraMap__SWIG_3(unsigned long const *far Teuchos::RCP< Teuchos::Comm< int > const > tempnull3 ; Tpetra::Map< LO,GO,NO > *result = 0 ; - arg1 = *farg1; - arg2 = *farg2; - arg3 = farg3->ptr ? static_cast< Teuchos::RCP< Teuchos::Comm< int > const > * >(farg3->ptr) : &tempnull3; + arg1 = static_cast< Tpetra::global_size_t >(*farg1); + arg2 = static_cast< size_t >(*farg2); + arg3 = farg3->cptr ? static_cast< Teuchos::RCP< Teuchos::Comm< int > const > * >(farg3->cptr) : &tempnull3; { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::Map< LO,GO,NO >::Map(Tpetra::global_size_t,size_t,Teuchos::RCP< Teuchos::Comm< int > const > const &)");; @@ -2226,13 +2238,13 @@ SWIGEXPORT SwigClassWrapper _wrap_new_TpetraMap__SWIG_3(unsigned long const *far SWIG_exception_impl("Tpetra::Map< LO,GO,NO >::Map(Tpetra::global_size_t,size_t,Teuchos::RCP< Teuchos::Comm< int > const > const &)", SWIG_UnknownError, "An unknown exception occurred", return SwigClassWrapper_uninitialized()); } } - fresult.ptr = result ? new Teuchos::RCP< Tpetra::Map >(result SWIG_NO_NULL_DELETER_1) : NULL; + fresult.cptr = result ? new Teuchos::RCP< Tpetra::Map >(result SWIG_NO_NULL_DELETER_1) : NULL; fresult.mem = SWIG_MOVE; return fresult; } -SWIGEXPORT SwigClassWrapper _wrap_new_TpetraMap__SWIG_4(unsigned long const *farg1, SwigArrayWrapper *farg2, SwigClassWrapper const *farg3) { +SWIGEXPORT SwigClassWrapper _wrap_new_TpetraMap__SWIG_4(long const *farg1, SwigArrayWrapper *farg2, SwigClassWrapper const *farg3) { SwigClassWrapper fresult ; Tpetra::global_size_t arg1 ; std::pair< GO const *,std::size_t > arg2 ; @@ -2240,10 +2252,10 @@ SWIGEXPORT SwigClassWrapper _wrap_new_TpetraMap__SWIG_4(unsigned long const *far Teuchos::RCP< Teuchos::Comm< int > const > tempnull3 ; Tpetra::Map< LO,GO,NO > *result = 0 ; - arg1 = *farg1; + arg1 = static_cast< Tpetra::global_size_t >(*farg1); (&arg2)->first = static_cast(farg2->data); (&arg2)->second = farg2->size; - arg3 = farg3->ptr ? static_cast< Teuchos::RCP< Teuchos::Comm< int > const > * >(farg3->ptr) : &tempnull3; + arg3 = farg3->cptr ? static_cast< Teuchos::RCP< Teuchos::Comm< int > const > * >(farg3->cptr) : &tempnull3; { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::Map< LO,GO,NO >::Map(Tpetra::global_size_t const,std::pair< GO const *,std::size_t >,Teuchos::RCP< Teuchos::Comm< int > const > const &)");; @@ -2267,7 +2279,7 @@ SWIGEXPORT SwigClassWrapper _wrap_new_TpetraMap__SWIG_4(unsigned long const *far SWIG_exception_impl("Tpetra::Map< LO,GO,NO >::Map(Tpetra::global_size_t const,std::pair< GO const *,std::size_t >,Teuchos::RCP< Teuchos::Comm< int > const > const &)", SWIG_UnknownError, "An unknown exception occurred", return SwigClassWrapper_uninitialized()); } } - fresult.ptr = result ? new Teuchos::RCP< Tpetra::Map >(result SWIG_NO_NULL_DELETER_1) : NULL; + fresult.cptr = result ? new Teuchos::RCP< Tpetra::Map >(result SWIG_NO_NULL_DELETER_1) : NULL; fresult.mem = SWIG_MOVE; return fresult; } @@ -2282,8 +2294,8 @@ SWIGEXPORT int _wrap_TpetraMap_getRemoteIndexList__SWIG_0(SwigClassWrapper const Teuchos::RCP< Tpetra::Map< LO,GO,NO > const > *smartarg1 ; Tpetra::LookupStatus result; - smartarg1 = static_cast< Teuchos::RCP >* >(farg1->ptr); - arg1 = smartarg1 ? const_cast*>(smartarg1->get()) : NULL; + smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::Map* >(smartarg1->get()) : NULL; (&arg2)->first = static_cast(farg2->data); (&arg2)->second = farg2->size; (&arg3)->first = static_cast(farg3->data); @@ -2326,8 +2338,8 @@ SWIGEXPORT int _wrap_TpetraMap_getRemoteIndexList__SWIG_1(SwigClassWrapper const Teuchos::RCP< Tpetra::Map< LO,GO,NO > const > *smartarg1 ; Tpetra::LookupStatus result; - smartarg1 = static_cast< Teuchos::RCP >* >(farg1->ptr); - arg1 = smartarg1 ? const_cast*>(smartarg1->get()) : NULL; + smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::Map* >(smartarg1->get()) : NULL; (&arg2)->first = static_cast(farg2->data); (&arg2)->second = farg2->size; (&arg3)->first = static_cast(farg3->data); @@ -2366,8 +2378,8 @@ SWIGEXPORT SwigArrayWrapper _wrap_TpetraMap_getNodeElementList(SwigClassWrapper Teuchos::RCP< Tpetra::Map< LO,GO,NO > const > *smartarg1 ; std::pair< GO const *,std::size_t > result; - smartarg1 = static_cast< Teuchos::RCP >* >(farg1->ptr); - arg1 = smartarg1 ? const_cast*>(smartarg1->get()) : NULL; + smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::Map* >(smartarg1->get()) : NULL; { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::Map< LO,GO,NO >::getNodeElementList() const");; @@ -2398,7 +2410,7 @@ SWIGEXPORT SwigArrayWrapper _wrap_TpetraMap_getNodeElementList(SwigClassWrapper SWIGEXPORT void _wrap_assign_TpetraMap(SwigClassWrapper * self, SwigClassWrapper const * other) { - typedef ::Teuchos::RCP< Tpetra::Map > swig_lhs_classtype; + typedef Teuchos::RCP< Tpetra::Map > swig_lhs_classtype; SWIG_assign(swig_lhs_classtype, self, swig_lhs_classtype, const_cast(other), 0 | swig::IS_DESTR | swig::IS_COPY_CONSTR); @@ -2413,8 +2425,8 @@ SWIGEXPORT SwigClassWrapper _wrap_new_TpetraExport__SWIG_0(SwigClassWrapper cons Teuchos::RCP< Tpetra::Export< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > tempnull2 ; Tpetra::Export< LO,GO,NO > *result = 0 ; - arg1 = farg1->ptr ? static_cast< Teuchos::RCP< Tpetra::Export< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg1->ptr) : &tempnull1; - arg2 = farg2->ptr ? static_cast< Teuchos::RCP< Tpetra::Export< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg2->ptr) : &tempnull2; + arg1 = farg1->cptr ? static_cast< Teuchos::RCP< Tpetra::Export< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg1->cptr) : &tempnull1; + arg2 = farg2->cptr ? static_cast< Teuchos::RCP< Tpetra::Export< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg2->cptr) : &tempnull2; { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::Export< LO,GO,NO >::Export(Teuchos::RCP< Tpetra::Export< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::Export< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &)");; @@ -2438,7 +2450,7 @@ SWIGEXPORT SwigClassWrapper _wrap_new_TpetraExport__SWIG_0(SwigClassWrapper cons SWIG_exception_impl("Tpetra::Export< LO,GO,NO >::Export(Teuchos::RCP< Tpetra::Export< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::Export< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &)", SWIG_UnknownError, "An unknown exception occurred", return SwigClassWrapper_uninitialized()); } } - fresult.ptr = result ? new Teuchos::RCP< Tpetra::Export >(result SWIG_NO_NULL_DELETER_1) : NULL; + fresult.cptr = result ? new Teuchos::RCP< Tpetra::Export >(result SWIG_NO_NULL_DELETER_1) : NULL; fresult.mem = SWIG_MOVE; return fresult; } @@ -2454,9 +2466,9 @@ SWIGEXPORT SwigClassWrapper _wrap_new_TpetraExport__SWIG_1(SwigClassWrapper cons Teuchos::RCP< Teuchos::ParameterList > tempnull3 ; Tpetra::Export< LO,GO,NO > *result = 0 ; - arg1 = farg1->ptr ? static_cast< Teuchos::RCP< Tpetra::Export< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg1->ptr) : &tempnull1; - arg2 = farg2->ptr ? static_cast< Teuchos::RCP< Tpetra::Export< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg2->ptr) : &tempnull2; - arg3 = farg3->ptr ? static_cast< Teuchos::RCP< Teuchos::ParameterList > * >(farg3->ptr) : &tempnull3; + arg1 = farg1->cptr ? static_cast< Teuchos::RCP< Tpetra::Export< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg1->cptr) : &tempnull1; + arg2 = farg2->cptr ? static_cast< Teuchos::RCP< Tpetra::Export< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg2->cptr) : &tempnull2; + arg3 = farg3->cptr ? static_cast< Teuchos::RCP< Teuchos::ParameterList > * >(farg3->cptr) : &tempnull3; { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::Export< LO,GO,NO >::Export(Teuchos::RCP< Tpetra::Export< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::Export< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Teuchos::ParameterList > const &)");; @@ -2480,7 +2492,7 @@ SWIGEXPORT SwigClassWrapper _wrap_new_TpetraExport__SWIG_1(SwigClassWrapper cons SWIG_exception_impl("Tpetra::Export< LO,GO,NO >::Export(Teuchos::RCP< Tpetra::Export< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::Export< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Teuchos::ParameterList > const &)", SWIG_UnknownError, "An unknown exception occurred", return SwigClassWrapper_uninitialized()); } } - fresult.ptr = result ? new Teuchos::RCP< Tpetra::Export >(result SWIG_NO_NULL_DELETER_1) : NULL; + fresult.cptr = result ? new Teuchos::RCP< Tpetra::Export >(result SWIG_NO_NULL_DELETER_1) : NULL; fresult.mem = SWIG_MOVE; return fresult; } @@ -2493,8 +2505,8 @@ SWIGEXPORT SwigClassWrapper _wrap_new_TpetraExport__SWIG_2(SwigClassWrapper cons Tpetra::Export< LO,GO,NO > *result = 0 ; SWIG_check_sp_nonnull(farg1, "Tpetra::Export< int,long long,Kokkos::Compat::KokkosSerialWrapperNode > *", "TpetraExport", "Tpetra::Export< LO,GO,NO >::Export(Tpetra::Export< int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &)", return SwigClassWrapper_uninitialized()) - smartarg1 = static_cast< Teuchos::RCP >* >(farg1->ptr); - arg1 = const_cast*>(smartarg1->get()); + smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); + arg1 = const_cast< Tpetra::Export* >(smartarg1->get()); { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::Export< LO,GO,NO >::Export(Tpetra::Export< int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &)");; @@ -2518,7 +2530,7 @@ SWIGEXPORT SwigClassWrapper _wrap_new_TpetraExport__SWIG_2(SwigClassWrapper cons SWIG_exception_impl("Tpetra::Export< LO,GO,NO >::Export(Tpetra::Export< int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &)", SWIG_UnknownError, "An unknown exception occurred", return SwigClassWrapper_uninitialized()); } } - fresult.ptr = result ? new Teuchos::RCP< Tpetra::Export >(result SWIG_NO_NULL_DELETER_1) : NULL; + fresult.cptr = result ? new Teuchos::RCP< Tpetra::Export >(result SWIG_NO_NULL_DELETER_1) : NULL; fresult.mem = SWIG_MOVE; return fresult; } @@ -2529,8 +2541,8 @@ SWIGEXPORT SwigClassWrapper _wrap_new_TpetraExport__SWIG_3(SwigClassWrapper cons Import< int,long long,Kokkos::Compat::KokkosSerialWrapperNode > *arg1 = 0 ; Tpetra::Export< LO,GO,NO > *result = 0 ; - SWIG_check_nonnull(*farg1, "Import< int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &", "SwigUnknownClass", "Tpetra::Export< LO,GO,NO >::Export(Import< int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &)", return SwigClassWrapper_uninitialized()); - arg1 = static_cast< Import< int,long long,Kokkos::Compat::KokkosSerialWrapperNode > * >(farg1->ptr); + SWIG_check_nonnull(*farg1, "Import< int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &", "SWIGTYPE_ImportT_int_long_long_Kokkos__Compat__KokkosSeri1YW4XR", "Tpetra::Export< LO,GO,NO >::Export(Import< int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &)", return SwigClassWrapper_uninitialized()); + arg1 = static_cast< Import< int,long long,Kokkos::Compat::KokkosSerialWrapperNode > * >(farg1->cptr); { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::Export< LO,GO,NO >::Export(Import< int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &)");; @@ -2554,7 +2566,7 @@ SWIGEXPORT SwigClassWrapper _wrap_new_TpetraExport__SWIG_3(SwigClassWrapper cons SWIG_exception_impl("Tpetra::Export< LO,GO,NO >::Export(Import< int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &)", SWIG_UnknownError, "An unknown exception occurred", return SwigClassWrapper_uninitialized()); } } - fresult.ptr = result ? new Teuchos::RCP< Tpetra::Export >(result SWIG_NO_NULL_DELETER_1) : NULL; + fresult.cptr = result ? new Teuchos::RCP< Tpetra::Export >(result SWIG_NO_NULL_DELETER_1) : NULL; fresult.mem = SWIG_MOVE; return fresult; } @@ -2564,8 +2576,8 @@ SWIGEXPORT void _wrap_delete_TpetraExport(SwigClassWrapper const *farg1) { Tpetra::Export< LO,GO,NO > *arg1 = (Tpetra::Export< LO,GO,NO > *) 0 ; Teuchos::RCP< Tpetra::Export< LO,GO,NO > > *smartarg1 ; - smartarg1 = static_cast< Teuchos::RCP< Tpetra::Export >* >(farg1->ptr); - arg1 = smartarg1 ? smartarg1->get() : NULL; + smartarg1 = static_cast< Teuchos::RCP< Tpetra::Export >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::Export* >(smartarg1->get()) : NULL; { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::Export< LO,GO,NO >::~Export()");; @@ -2599,9 +2611,9 @@ SWIGEXPORT void _wrap_TpetraExport_setParameterList(SwigClassWrapper const *farg Teuchos::RCP< Tpetra::Export< LO,GO,NO > > *smartarg1 ; Teuchos::RCP< Teuchos::ParameterList > tempnull2 ; - smartarg1 = static_cast< Teuchos::RCP< Tpetra::Export >* >(farg1->ptr); - arg1 = smartarg1 ? smartarg1->get() : NULL; - arg2 = farg2->ptr ? static_cast< Teuchos::RCP< Teuchos::ParameterList > * >(farg2->ptr) : &tempnull2; + smartarg1 = static_cast< Teuchos::RCP< Tpetra::Export >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::Export* >(smartarg1->get()) : NULL; + arg2 = farg2->cptr ? static_cast< Teuchos::RCP< Teuchos::ParameterList > * >(farg2->cptr) : &tempnull2; { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::Export< LO,GO,NO >::setParameterList(Teuchos::RCP< Teuchos::ParameterList > const &)");; @@ -2635,8 +2647,8 @@ SWIGEXPORT size_t _wrap_TpetraExport_getNumSameIDs(SwigClassWrapper const *farg1 Teuchos::RCP< Tpetra::Export< LO,GO,NO > const > *smartarg1 ; size_t result; - smartarg1 = static_cast< Teuchos::RCP >* >(farg1->ptr); - arg1 = smartarg1 ? const_cast*>(smartarg1->get()) : NULL; + smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::Export* >(smartarg1->get()) : NULL; { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::Export< LO,GO,NO >::getNumSameIDs() const");; @@ -2660,7 +2672,7 @@ SWIGEXPORT size_t _wrap_TpetraExport_getNumSameIDs(SwigClassWrapper const *farg1 SWIG_exception_impl("Tpetra::Export< LO,GO,NO >::getNumSameIDs() const", SWIG_UnknownError, "An unknown exception occurred", return 0); } } - fresult = result; + fresult = static_cast< size_t >(result); return fresult; } @@ -2671,8 +2683,8 @@ SWIGEXPORT size_t _wrap_TpetraExport_getNumPermuteIDs(SwigClassWrapper const *fa Teuchos::RCP< Tpetra::Export< LO,GO,NO > const > *smartarg1 ; size_t result; - smartarg1 = static_cast< Teuchos::RCP >* >(farg1->ptr); - arg1 = smartarg1 ? const_cast*>(smartarg1->get()) : NULL; + smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::Export* >(smartarg1->get()) : NULL; { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::Export< LO,GO,NO >::getNumPermuteIDs() const");; @@ -2696,7 +2708,7 @@ SWIGEXPORT size_t _wrap_TpetraExport_getNumPermuteIDs(SwigClassWrapper const *fa SWIG_exception_impl("Tpetra::Export< LO,GO,NO >::getNumPermuteIDs() const", SWIG_UnknownError, "An unknown exception occurred", return 0); } } - fresult = result; + fresult = static_cast< size_t >(result); return fresult; } @@ -2707,8 +2719,8 @@ SWIGEXPORT size_t _wrap_TpetraExport_getNumRemoteIDs(SwigClassWrapper const *far Teuchos::RCP< Tpetra::Export< LO,GO,NO > const > *smartarg1 ; size_t result; - smartarg1 = static_cast< Teuchos::RCP >* >(farg1->ptr); - arg1 = smartarg1 ? const_cast*>(smartarg1->get()) : NULL; + smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::Export* >(smartarg1->get()) : NULL; { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::Export< LO,GO,NO >::getNumRemoteIDs() const");; @@ -2732,7 +2744,7 @@ SWIGEXPORT size_t _wrap_TpetraExport_getNumRemoteIDs(SwigClassWrapper const *far SWIG_exception_impl("Tpetra::Export< LO,GO,NO >::getNumRemoteIDs() const", SWIG_UnknownError, "An unknown exception occurred", return 0); } } - fresult = result; + fresult = static_cast< size_t >(result); return fresult; } @@ -2743,8 +2755,8 @@ SWIGEXPORT size_t _wrap_TpetraExport_getNumExportIDs(SwigClassWrapper const *far Teuchos::RCP< Tpetra::Export< LO,GO,NO > const > *smartarg1 ; size_t result; - smartarg1 = static_cast< Teuchos::RCP >* >(farg1->ptr); - arg1 = smartarg1 ? const_cast*>(smartarg1->get()) : NULL; + smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::Export* >(smartarg1->get()) : NULL; { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::Export< LO,GO,NO >::getNumExportIDs() const");; @@ -2768,7 +2780,7 @@ SWIGEXPORT size_t _wrap_TpetraExport_getNumExportIDs(SwigClassWrapper const *far SWIG_exception_impl("Tpetra::Export< LO,GO,NO >::getNumExportIDs() const", SWIG_UnknownError, "An unknown exception occurred", return 0); } } - fresult = result; + fresult = static_cast< size_t >(result); return fresult; } @@ -2779,8 +2791,8 @@ SWIGEXPORT SwigClassWrapper _wrap_TpetraExport_getSourceMap(SwigClassWrapper con Teuchos::RCP< Tpetra::Export< LO,GO,NO > const > *smartarg1 ; Teuchos::RCP< Tpetra::Export< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > result; - smartarg1 = static_cast< Teuchos::RCP >* >(farg1->ptr); - arg1 = smartarg1 ? const_cast*>(smartarg1->get()) : NULL; + smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::Export* >(smartarg1->get()) : NULL; { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::Export< LO,GO,NO >::getSourceMap() const");; @@ -2804,7 +2816,7 @@ SWIGEXPORT SwigClassWrapper _wrap_TpetraExport_getSourceMap(SwigClassWrapper con SWIG_exception_impl("Tpetra::Export< LO,GO,NO >::getSourceMap() const", SWIG_UnknownError, "An unknown exception occurred", return SwigClassWrapper_uninitialized()); } } - fresult.ptr = (new Teuchos::RCP >(static_cast< const Teuchos::RCP >& >(result))); + fresult.cptr = (new Teuchos::RCP >(static_cast< const Teuchos::RCP >& >(result))); fresult.mem = SWIG_MOVE; return fresult; } @@ -2816,8 +2828,8 @@ SWIGEXPORT SwigClassWrapper _wrap_TpetraExport_getTargetMap(SwigClassWrapper con Teuchos::RCP< Tpetra::Export< LO,GO,NO > const > *smartarg1 ; Teuchos::RCP< Tpetra::Export< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > result; - smartarg1 = static_cast< Teuchos::RCP >* >(farg1->ptr); - arg1 = smartarg1 ? const_cast*>(smartarg1->get()) : NULL; + smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::Export* >(smartarg1->get()) : NULL; { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::Export< LO,GO,NO >::getTargetMap() const");; @@ -2841,7 +2853,7 @@ SWIGEXPORT SwigClassWrapper _wrap_TpetraExport_getTargetMap(SwigClassWrapper con SWIG_exception_impl("Tpetra::Export< LO,GO,NO >::getTargetMap() const", SWIG_UnknownError, "An unknown exception occurred", return SwigClassWrapper_uninitialized()); } } - fresult.ptr = (new Teuchos::RCP >(static_cast< const Teuchos::RCP >& >(result))); + fresult.cptr = (new Teuchos::RCP >(static_cast< const Teuchos::RCP >& >(result))); fresult.mem = SWIG_MOVE; return fresult; } @@ -2853,8 +2865,8 @@ SWIGEXPORT bool _wrap_TpetraExport_isLocallyComplete(SwigClassWrapper const *far Teuchos::RCP< Tpetra::Export< LO,GO,NO > const > *smartarg1 ; bool result; - smartarg1 = static_cast< Teuchos::RCP >* >(farg1->ptr); - arg1 = smartarg1 ? const_cast*>(smartarg1->get()) : NULL; + smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::Export* >(smartarg1->get()) : NULL; { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::Export< LO,GO,NO >::isLocallyComplete() const");; @@ -2878,13 +2890,13 @@ SWIGEXPORT bool _wrap_TpetraExport_isLocallyComplete(SwigClassWrapper const *far SWIG_exception_impl("Tpetra::Export< LO,GO,NO >::isLocallyComplete() const", SWIG_UnknownError, "An unknown exception occurred", return 0); } } - fresult = result; + fresult = static_cast< bool >(result); return fresult; } SWIGEXPORT void _wrap_assign_TpetraExport(SwigClassWrapper * self, SwigClassWrapper const * other) { - typedef ::Teuchos::RCP< Tpetra::Export > swig_lhs_classtype; + typedef Teuchos::RCP< Tpetra::Export > swig_lhs_classtype; SWIG_assign(swig_lhs_classtype, self, swig_lhs_classtype, const_cast(other), 0 | swig::IS_DESTR | swig::IS_COPY_CONSTR | swig::IS_COPY_ASSIGN); @@ -2899,8 +2911,8 @@ SWIGEXPORT SwigClassWrapper _wrap_new_TpetraImport__SWIG_0(SwigClassWrapper cons Teuchos::RCP< Tpetra::Import< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > tempnull2 ; Tpetra::Import< LO,GO,NO > *result = 0 ; - arg1 = farg1->ptr ? static_cast< Teuchos::RCP< Tpetra::Import< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg1->ptr) : &tempnull1; - arg2 = farg2->ptr ? static_cast< Teuchos::RCP< Tpetra::Import< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg2->ptr) : &tempnull2; + arg1 = farg1->cptr ? static_cast< Teuchos::RCP< Tpetra::Import< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg1->cptr) : &tempnull1; + arg2 = farg2->cptr ? static_cast< Teuchos::RCP< Tpetra::Import< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg2->cptr) : &tempnull2; { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::Import< LO,GO,NO >::Import(Teuchos::RCP< Tpetra::Import< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::Import< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &)");; @@ -2924,7 +2936,7 @@ SWIGEXPORT SwigClassWrapper _wrap_new_TpetraImport__SWIG_0(SwigClassWrapper cons SWIG_exception_impl("Tpetra::Import< LO,GO,NO >::Import(Teuchos::RCP< Tpetra::Import< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::Import< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &)", SWIG_UnknownError, "An unknown exception occurred", return SwigClassWrapper_uninitialized()); } } - fresult.ptr = result ? new Teuchos::RCP< Tpetra::Import >(result SWIG_NO_NULL_DELETER_1) : NULL; + fresult.cptr = result ? new Teuchos::RCP< Tpetra::Import >(result SWIG_NO_NULL_DELETER_1) : NULL; fresult.mem = SWIG_MOVE; return fresult; } @@ -2940,9 +2952,9 @@ SWIGEXPORT SwigClassWrapper _wrap_new_TpetraImport__SWIG_1(SwigClassWrapper cons Teuchos::RCP< Teuchos::ParameterList > tempnull3 ; Tpetra::Import< LO,GO,NO > *result = 0 ; - arg1 = farg1->ptr ? static_cast< Teuchos::RCP< Tpetra::Import< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg1->ptr) : &tempnull1; - arg2 = farg2->ptr ? static_cast< Teuchos::RCP< Tpetra::Import< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg2->ptr) : &tempnull2; - arg3 = farg3->ptr ? static_cast< Teuchos::RCP< Teuchos::ParameterList > * >(farg3->ptr) : &tempnull3; + arg1 = farg1->cptr ? static_cast< Teuchos::RCP< Tpetra::Import< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg1->cptr) : &tempnull1; + arg2 = farg2->cptr ? static_cast< Teuchos::RCP< Tpetra::Import< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg2->cptr) : &tempnull2; + arg3 = farg3->cptr ? static_cast< Teuchos::RCP< Teuchos::ParameterList > * >(farg3->cptr) : &tempnull3; { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::Import< LO,GO,NO >::Import(Teuchos::RCP< Tpetra::Import< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::Import< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Teuchos::ParameterList > const &)");; @@ -2966,7 +2978,7 @@ SWIGEXPORT SwigClassWrapper _wrap_new_TpetraImport__SWIG_1(SwigClassWrapper cons SWIG_exception_impl("Tpetra::Import< LO,GO,NO >::Import(Teuchos::RCP< Tpetra::Import< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::Import< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Teuchos::ParameterList > const &)", SWIG_UnknownError, "An unknown exception occurred", return SwigClassWrapper_uninitialized()); } } - fresult.ptr = result ? new Teuchos::RCP< Tpetra::Import >(result SWIG_NO_NULL_DELETER_1) : NULL; + fresult.cptr = result ? new Teuchos::RCP< Tpetra::Import >(result SWIG_NO_NULL_DELETER_1) : NULL; fresult.mem = SWIG_MOVE; return fresult; } @@ -2979,8 +2991,8 @@ SWIGEXPORT SwigClassWrapper _wrap_new_TpetraImport__SWIG_2(SwigClassWrapper cons Tpetra::Import< LO,GO,NO > *result = 0 ; SWIG_check_sp_nonnull(farg1, "Tpetra::Import< int,long long,Kokkos::Compat::KokkosSerialWrapperNode > *", "TpetraImport", "Tpetra::Import< LO,GO,NO >::Import(Tpetra::Import< int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &)", return SwigClassWrapper_uninitialized()) - smartarg1 = static_cast< Teuchos::RCP >* >(farg1->ptr); - arg1 = const_cast*>(smartarg1->get()); + smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); + arg1 = const_cast< Tpetra::Import* >(smartarg1->get()); { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::Import< LO,GO,NO >::Import(Tpetra::Import< int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &)");; @@ -3004,7 +3016,7 @@ SWIGEXPORT SwigClassWrapper _wrap_new_TpetraImport__SWIG_2(SwigClassWrapper cons SWIG_exception_impl("Tpetra::Import< LO,GO,NO >::Import(Tpetra::Import< int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &)", SWIG_UnknownError, "An unknown exception occurred", return SwigClassWrapper_uninitialized()); } } - fresult.ptr = result ? new Teuchos::RCP< Tpetra::Import >(result SWIG_NO_NULL_DELETER_1) : NULL; + fresult.cptr = result ? new Teuchos::RCP< Tpetra::Import >(result SWIG_NO_NULL_DELETER_1) : NULL; fresult.mem = SWIG_MOVE; return fresult; } @@ -3017,8 +3029,8 @@ SWIGEXPORT SwigClassWrapper _wrap_new_TpetraImport__SWIG_3(SwigClassWrapper cons Tpetra::Import< LO,GO,NO > *result = 0 ; SWIG_check_sp_nonnull(farg1, "Tpetra::Export< int,long long,Kokkos::Compat::KokkosSerialWrapperNode > *", "TpetraExport", "Tpetra::Import< LO,GO,NO >::Import(Tpetra::Export< int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &)", return SwigClassWrapper_uninitialized()) - smartarg1 = static_cast< Teuchos::RCP >* >(farg1->ptr); - arg1 = const_cast*>(smartarg1->get()); + smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); + arg1 = const_cast< Tpetra::Export* >(smartarg1->get()); { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::Import< LO,GO,NO >::Import(Tpetra::Export< int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &)");; @@ -3042,7 +3054,7 @@ SWIGEXPORT SwigClassWrapper _wrap_new_TpetraImport__SWIG_3(SwigClassWrapper cons SWIG_exception_impl("Tpetra::Import< LO,GO,NO >::Import(Tpetra::Export< int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &)", SWIG_UnknownError, "An unknown exception occurred", return SwigClassWrapper_uninitialized()); } } - fresult.ptr = result ? new Teuchos::RCP< Tpetra::Import >(result SWIG_NO_NULL_DELETER_1) : NULL; + fresult.cptr = result ? new Teuchos::RCP< Tpetra::Import >(result SWIG_NO_NULL_DELETER_1) : NULL; fresult.mem = SWIG_MOVE; return fresult; } @@ -3052,8 +3064,8 @@ SWIGEXPORT void _wrap_delete_TpetraImport(SwigClassWrapper const *farg1) { Tpetra::Import< LO,GO,NO > *arg1 = (Tpetra::Import< LO,GO,NO > *) 0 ; Teuchos::RCP< Tpetra::Import< LO,GO,NO > > *smartarg1 ; - smartarg1 = static_cast< Teuchos::RCP< Tpetra::Import >* >(farg1->ptr); - arg1 = smartarg1 ? smartarg1->get() : NULL; + smartarg1 = static_cast< Teuchos::RCP< Tpetra::Import >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::Import* >(smartarg1->get()) : NULL; { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::Import< LO,GO,NO >::~Import()");; @@ -3087,9 +3099,9 @@ SWIGEXPORT void _wrap_TpetraImport_setParameterList(SwigClassWrapper const *farg Teuchos::RCP< Tpetra::Import< LO,GO,NO > > *smartarg1 ; Teuchos::RCP< Teuchos::ParameterList > tempnull2 ; - smartarg1 = static_cast< Teuchos::RCP< Tpetra::Import >* >(farg1->ptr); - arg1 = smartarg1 ? smartarg1->get() : NULL; - arg2 = farg2->ptr ? static_cast< Teuchos::RCP< Teuchos::ParameterList > * >(farg2->ptr) : &tempnull2; + smartarg1 = static_cast< Teuchos::RCP< Tpetra::Import >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::Import* >(smartarg1->get()) : NULL; + arg2 = farg2->cptr ? static_cast< Teuchos::RCP< Teuchos::ParameterList > * >(farg2->cptr) : &tempnull2; { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::Import< LO,GO,NO >::setParameterList(Teuchos::RCP< Teuchos::ParameterList > const &)");; @@ -3123,8 +3135,8 @@ SWIGEXPORT size_t _wrap_TpetraImport_getNumSameIDs(SwigClassWrapper const *farg1 Teuchos::RCP< Tpetra::Import< LO,GO,NO > const > *smartarg1 ; size_t result; - smartarg1 = static_cast< Teuchos::RCP >* >(farg1->ptr); - arg1 = smartarg1 ? const_cast*>(smartarg1->get()) : NULL; + smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::Import* >(smartarg1->get()) : NULL; { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::Import< LO,GO,NO >::getNumSameIDs() const");; @@ -3148,7 +3160,7 @@ SWIGEXPORT size_t _wrap_TpetraImport_getNumSameIDs(SwigClassWrapper const *farg1 SWIG_exception_impl("Tpetra::Import< LO,GO,NO >::getNumSameIDs() const", SWIG_UnknownError, "An unknown exception occurred", return 0); } } - fresult = result; + fresult = static_cast< size_t >(result); return fresult; } @@ -3159,8 +3171,8 @@ SWIGEXPORT size_t _wrap_TpetraImport_getNumPermuteIDs(SwigClassWrapper const *fa Teuchos::RCP< Tpetra::Import< LO,GO,NO > const > *smartarg1 ; size_t result; - smartarg1 = static_cast< Teuchos::RCP >* >(farg1->ptr); - arg1 = smartarg1 ? const_cast*>(smartarg1->get()) : NULL; + smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::Import* >(smartarg1->get()) : NULL; { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::Import< LO,GO,NO >::getNumPermuteIDs() const");; @@ -3184,7 +3196,7 @@ SWIGEXPORT size_t _wrap_TpetraImport_getNumPermuteIDs(SwigClassWrapper const *fa SWIG_exception_impl("Tpetra::Import< LO,GO,NO >::getNumPermuteIDs() const", SWIG_UnknownError, "An unknown exception occurred", return 0); } } - fresult = result; + fresult = static_cast< size_t >(result); return fresult; } @@ -3195,8 +3207,8 @@ SWIGEXPORT size_t _wrap_TpetraImport_getNumRemoteIDs(SwigClassWrapper const *far Teuchos::RCP< Tpetra::Import< LO,GO,NO > const > *smartarg1 ; size_t result; - smartarg1 = static_cast< Teuchos::RCP >* >(farg1->ptr); - arg1 = smartarg1 ? const_cast*>(smartarg1->get()) : NULL; + smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::Import* >(smartarg1->get()) : NULL; { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::Import< LO,GO,NO >::getNumRemoteIDs() const");; @@ -3220,7 +3232,7 @@ SWIGEXPORT size_t _wrap_TpetraImport_getNumRemoteIDs(SwigClassWrapper const *far SWIG_exception_impl("Tpetra::Import< LO,GO,NO >::getNumRemoteIDs() const", SWIG_UnknownError, "An unknown exception occurred", return 0); } } - fresult = result; + fresult = static_cast< size_t >(result); return fresult; } @@ -3231,8 +3243,8 @@ SWIGEXPORT size_t _wrap_TpetraImport_getNumExportIDs(SwigClassWrapper const *far Teuchos::RCP< Tpetra::Import< LO,GO,NO > const > *smartarg1 ; size_t result; - smartarg1 = static_cast< Teuchos::RCP >* >(farg1->ptr); - arg1 = smartarg1 ? const_cast*>(smartarg1->get()) : NULL; + smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::Import* >(smartarg1->get()) : NULL; { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::Import< LO,GO,NO >::getNumExportIDs() const");; @@ -3256,7 +3268,7 @@ SWIGEXPORT size_t _wrap_TpetraImport_getNumExportIDs(SwigClassWrapper const *far SWIG_exception_impl("Tpetra::Import< LO,GO,NO >::getNumExportIDs() const", SWIG_UnknownError, "An unknown exception occurred", return 0); } } - fresult = result; + fresult = static_cast< size_t >(result); return fresult; } @@ -3267,8 +3279,8 @@ SWIGEXPORT SwigClassWrapper _wrap_TpetraImport_getSourceMap(SwigClassWrapper con Teuchos::RCP< Tpetra::Import< LO,GO,NO > const > *smartarg1 ; Teuchos::RCP< Tpetra::Import< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > result; - smartarg1 = static_cast< Teuchos::RCP >* >(farg1->ptr); - arg1 = smartarg1 ? const_cast*>(smartarg1->get()) : NULL; + smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::Import* >(smartarg1->get()) : NULL; { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::Import< LO,GO,NO >::getSourceMap() const");; @@ -3292,7 +3304,7 @@ SWIGEXPORT SwigClassWrapper _wrap_TpetraImport_getSourceMap(SwigClassWrapper con SWIG_exception_impl("Tpetra::Import< LO,GO,NO >::getSourceMap() const", SWIG_UnknownError, "An unknown exception occurred", return SwigClassWrapper_uninitialized()); } } - fresult.ptr = (new Teuchos::RCP >(static_cast< const Teuchos::RCP >& >(result))); + fresult.cptr = (new Teuchos::RCP >(static_cast< const Teuchos::RCP >& >(result))); fresult.mem = SWIG_MOVE; return fresult; } @@ -3304,8 +3316,8 @@ SWIGEXPORT SwigClassWrapper _wrap_TpetraImport_getTargetMap(SwigClassWrapper con Teuchos::RCP< Tpetra::Import< LO,GO,NO > const > *smartarg1 ; Teuchos::RCP< Tpetra::Import< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > result; - smartarg1 = static_cast< Teuchos::RCP >* >(farg1->ptr); - arg1 = smartarg1 ? const_cast*>(smartarg1->get()) : NULL; + smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::Import* >(smartarg1->get()) : NULL; { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::Import< LO,GO,NO >::getTargetMap() const");; @@ -3329,7 +3341,7 @@ SWIGEXPORT SwigClassWrapper _wrap_TpetraImport_getTargetMap(SwigClassWrapper con SWIG_exception_impl("Tpetra::Import< LO,GO,NO >::getTargetMap() const", SWIG_UnknownError, "An unknown exception occurred", return SwigClassWrapper_uninitialized()); } } - fresult.ptr = (new Teuchos::RCP >(static_cast< const Teuchos::RCP >& >(result))); + fresult.cptr = (new Teuchos::RCP >(static_cast< const Teuchos::RCP >& >(result))); fresult.mem = SWIG_MOVE; return fresult; } @@ -3341,8 +3353,8 @@ SWIGEXPORT bool _wrap_TpetraImport_isLocallyComplete(SwigClassWrapper const *far Teuchos::RCP< Tpetra::Import< LO,GO,NO > const > *smartarg1 ; bool result; - smartarg1 = static_cast< Teuchos::RCP >* >(farg1->ptr); - arg1 = smartarg1 ? const_cast*>(smartarg1->get()) : NULL; + smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::Import* >(smartarg1->get()) : NULL; { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::Import< LO,GO,NO >::isLocallyComplete() const");; @@ -3366,7 +3378,7 @@ SWIGEXPORT bool _wrap_TpetraImport_isLocallyComplete(SwigClassWrapper const *far SWIG_exception_impl("Tpetra::Import< LO,GO,NO >::isLocallyComplete() const", SWIG_UnknownError, "An unknown exception occurred", return 0); } } - fresult = result; + fresult = static_cast< bool >(result); return fresult; } @@ -3379,11 +3391,11 @@ SWIGEXPORT SwigClassWrapper _wrap_TpetraImport_setUnion__SWIG_0(SwigClassWrapper Teuchos::RCP< Tpetra::Import< LO,GO,NO > const > *smartarg2 ; Teuchos::RCP< Tpetra::Import< int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const > result; - smartarg1 = static_cast< Teuchos::RCP >* >(farg1->ptr); - arg1 = smartarg1 ? const_cast*>(smartarg1->get()) : NULL; + smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::Import* >(smartarg1->get()) : NULL; SWIG_check_sp_nonnull(farg2, "Tpetra::Import< int,long long,Kokkos::Compat::KokkosSerialWrapperNode > *", "TpetraImport", "Tpetra::Import< LO,GO,NO >::setUnion(Tpetra::Import< int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &) const", return SwigClassWrapper_uninitialized()) - smartarg2 = static_cast< Teuchos::RCP >* >(farg2->ptr); - arg2 = const_cast*>(smartarg2->get()); + smartarg2 = static_cast< Teuchos::RCP >* >(farg2->cptr); + arg2 = const_cast< Tpetra::Import* >(smartarg2->get()); { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::Import< LO,GO,NO >::setUnion(Tpetra::Import< int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &) const");; @@ -3407,7 +3419,7 @@ SWIGEXPORT SwigClassWrapper _wrap_TpetraImport_setUnion__SWIG_0(SwigClassWrapper SWIG_exception_impl("Tpetra::Import< LO,GO,NO >::setUnion(Tpetra::Import< int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &) const", SWIG_UnknownError, "An unknown exception occurred", return SwigClassWrapper_uninitialized()); } } - fresult.ptr = (new Teuchos::RCP >(static_cast< const Teuchos::RCP >& >(result))); + fresult.cptr = (new Teuchos::RCP >(static_cast< const Teuchos::RCP >& >(result))); fresult.mem = SWIG_MOVE; return fresult; } @@ -3419,8 +3431,8 @@ SWIGEXPORT SwigClassWrapper _wrap_TpetraImport_setUnion__SWIG_1(SwigClassWrapper Teuchos::RCP< Tpetra::Import< LO,GO,NO > const > *smartarg1 ; Teuchos::RCP< Tpetra::Import< int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const > result; - smartarg1 = static_cast< Teuchos::RCP >* >(farg1->ptr); - arg1 = smartarg1 ? const_cast*>(smartarg1->get()) : NULL; + smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::Import* >(smartarg1->get()) : NULL; { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::Import< LO,GO,NO >::setUnion() const");; @@ -3444,7 +3456,7 @@ SWIGEXPORT SwigClassWrapper _wrap_TpetraImport_setUnion__SWIG_1(SwigClassWrapper SWIG_exception_impl("Tpetra::Import< LO,GO,NO >::setUnion() const", SWIG_UnknownError, "An unknown exception occurred", return SwigClassWrapper_uninitialized()); } } - fresult.ptr = (new Teuchos::RCP >(static_cast< const Teuchos::RCP >& >(result))); + fresult.cptr = (new Teuchos::RCP >(static_cast< const Teuchos::RCP >& >(result))); fresult.mem = SWIG_MOVE; return fresult; } @@ -3458,9 +3470,9 @@ SWIGEXPORT SwigClassWrapper _wrap_TpetraImport_createRemoteOnlyImport(SwigClassW Teuchos::RCP< Tpetra::Import< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > tempnull2 ; Teuchos::RCP< Tpetra::Import< int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const > result; - smartarg1 = static_cast< Teuchos::RCP >* >(farg1->ptr); - arg1 = smartarg1 ? const_cast*>(smartarg1->get()) : NULL; - arg2 = farg2->ptr ? static_cast< Teuchos::RCP< Tpetra::Import< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg2->ptr) : &tempnull2; + smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::Import* >(smartarg1->get()) : NULL; + arg2 = farg2->cptr ? static_cast< Teuchos::RCP< Tpetra::Import< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg2->cptr) : &tempnull2; { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::Import< LO,GO,NO >::createRemoteOnlyImport(Teuchos::RCP< Tpetra::Import< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &) const");; @@ -3484,14 +3496,14 @@ SWIGEXPORT SwigClassWrapper _wrap_TpetraImport_createRemoteOnlyImport(SwigClassW SWIG_exception_impl("Tpetra::Import< LO,GO,NO >::createRemoteOnlyImport(Teuchos::RCP< Tpetra::Import< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &) const", SWIG_UnknownError, "An unknown exception occurred", return SwigClassWrapper_uninitialized()); } } - fresult.ptr = (new Teuchos::RCP >(static_cast< const Teuchos::RCP >& >(result))); + fresult.cptr = (new Teuchos::RCP >(static_cast< const Teuchos::RCP >& >(result))); fresult.mem = SWIG_MOVE; return fresult; } SWIGEXPORT void _wrap_assign_TpetraImport(SwigClassWrapper * self, SwigClassWrapper const * other) { - typedef ::Teuchos::RCP< Tpetra::Import > swig_lhs_classtype; + typedef Teuchos::RCP< Tpetra::Import > swig_lhs_classtype; SWIG_assign(swig_lhs_classtype, self, swig_lhs_classtype, const_cast(other), 0 | swig::IS_DESTR | swig::IS_COPY_CONSTR | swig::IS_COPY_ASSIGN); @@ -3525,7 +3537,7 @@ SWIGEXPORT SwigClassWrapper _wrap_new_TpetraMultiVector__SWIG_0() { SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::MultiVector()", SWIG_UnknownError, "An unknown exception occurred", return SwigClassWrapper_uninitialized()); } } - fresult.ptr = result ? new Teuchos::RCP< Tpetra::MultiVector >(result SWIG_NO_NULL_DELETER_1) : NULL; + fresult.cptr = result ? new Teuchos::RCP< Tpetra::MultiVector >(result SWIG_NO_NULL_DELETER_1) : NULL; fresult.mem = SWIG_MOVE; return fresult; } @@ -3539,9 +3551,9 @@ SWIGEXPORT SwigClassWrapper _wrap_new_TpetraMultiVector__SWIG_1(SwigClassWrapper Teuchos::RCP< Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > tempnull1 ; Tpetra::MultiVector< SC,LO,GO,NO > *result = 0 ; - arg1 = farg1->ptr ? static_cast< Teuchos::RCP< Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg1->ptr) : &tempnull1; - arg2 = *farg2; - arg3 = *farg3; + arg1 = farg1->cptr ? static_cast< Teuchos::RCP< Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg1->cptr) : &tempnull1; + arg2 = static_cast< size_t >(*farg2); + arg3 = static_cast< bool >(*farg3); { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::MultiVector(Teuchos::RCP< Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,size_t const,bool const)");; @@ -3565,7 +3577,7 @@ SWIGEXPORT SwigClassWrapper _wrap_new_TpetraMultiVector__SWIG_1(SwigClassWrapper SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::MultiVector(Teuchos::RCP< Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,size_t const,bool const)", SWIG_UnknownError, "An unknown exception occurred", return SwigClassWrapper_uninitialized()); } } - fresult.ptr = result ? new Teuchos::RCP< Tpetra::MultiVector >(result SWIG_NO_NULL_DELETER_1) : NULL; + fresult.cptr = result ? new Teuchos::RCP< Tpetra::MultiVector >(result SWIG_NO_NULL_DELETER_1) : NULL; fresult.mem = SWIG_MOVE; return fresult; } @@ -3578,8 +3590,8 @@ SWIGEXPORT SwigClassWrapper _wrap_new_TpetraMultiVector__SWIG_2(SwigClassWrapper Teuchos::RCP< Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > tempnull1 ; Tpetra::MultiVector< SC,LO,GO,NO > *result = 0 ; - arg1 = farg1->ptr ? static_cast< Teuchos::RCP< Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg1->ptr) : &tempnull1; - arg2 = *farg2; + arg1 = farg1->cptr ? static_cast< Teuchos::RCP< Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg1->cptr) : &tempnull1; + arg2 = static_cast< size_t >(*farg2); { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::MultiVector(Teuchos::RCP< Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,size_t const)");; @@ -3603,7 +3615,7 @@ SWIGEXPORT SwigClassWrapper _wrap_new_TpetraMultiVector__SWIG_2(SwigClassWrapper SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::MultiVector(Teuchos::RCP< Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,size_t const)", SWIG_UnknownError, "An unknown exception occurred", return SwigClassWrapper_uninitialized()); } } - fresult.ptr = result ? new Teuchos::RCP< Tpetra::MultiVector >(result SWIG_NO_NULL_DELETER_1) : NULL; + fresult.cptr = result ? new Teuchos::RCP< Tpetra::MultiVector >(result SWIG_NO_NULL_DELETER_1) : NULL; fresult.mem = SWIG_MOVE; return fresult; } @@ -3616,8 +3628,8 @@ SWIGEXPORT SwigClassWrapper _wrap_new_TpetraMultiVector__SWIG_3(SwigClassWrapper Tpetra::MultiVector< SC,LO,GO,NO > *result = 0 ; SWIG_check_sp_nonnull(farg1, "Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > *", "TpetraMultiVector", "Tpetra::MultiVector< SC,LO,GO,NO >::MultiVector(Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &)", return SwigClassWrapper_uninitialized()) - smartarg1 = static_cast< Teuchos::RCP >* >(farg1->ptr); - arg1 = const_cast*>(smartarg1->get()); + smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); + arg1 = const_cast< Tpetra::MultiVector* >(smartarg1->get()); { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::MultiVector(Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &)");; @@ -3641,7 +3653,7 @@ SWIGEXPORT SwigClassWrapper _wrap_new_TpetraMultiVector__SWIG_3(SwigClassWrapper SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::MultiVector(Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &)", SWIG_UnknownError, "An unknown exception occurred", return SwigClassWrapper_uninitialized()); } } - fresult.ptr = result ? new Teuchos::RCP< Tpetra::MultiVector >(result SWIG_NO_NULL_DELETER_1) : NULL; + fresult.cptr = result ? new Teuchos::RCP< Tpetra::MultiVector >(result SWIG_NO_NULL_DELETER_1) : NULL; fresult.mem = SWIG_MOVE; return fresult; } @@ -3655,8 +3667,8 @@ SWIGEXPORT SwigClassWrapper _wrap_new_TpetraMultiVector__SWIG_4(SwigClassWrapper Tpetra::MultiVector< SC,LO,GO,NO > *result = 0 ; SWIG_check_sp_nonnull(farg1, "Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > *", "TpetraMultiVector", "Tpetra::MultiVector< SC,LO,GO,NO >::MultiVector(Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &,Teuchos::DataAccess const)", return SwigClassWrapper_uninitialized()) - smartarg1 = static_cast< Teuchos::RCP >* >(farg1->ptr); - arg1 = const_cast*>(smartarg1->get()); + smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); + arg1 = const_cast< Tpetra::MultiVector* >(smartarg1->get()); arg2 = static_cast< Teuchos::DataAccess >(*farg2); { // Make sure no unhandled exceptions exist before performing a new action @@ -3681,7 +3693,7 @@ SWIGEXPORT SwigClassWrapper _wrap_new_TpetraMultiVector__SWIG_4(SwigClassWrapper SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::MultiVector(Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &,Teuchos::DataAccess const)", SWIG_UnknownError, "An unknown exception occurred", return SwigClassWrapper_uninitialized()); } } - fresult.ptr = result ? new Teuchos::RCP< Tpetra::MultiVector >(result SWIG_NO_NULL_DELETER_1) : NULL; + fresult.cptr = result ? new Teuchos::RCP< Tpetra::MultiVector >(result SWIG_NO_NULL_DELETER_1) : NULL; fresult.mem = SWIG_MOVE; return fresult; } @@ -3697,12 +3709,12 @@ SWIGEXPORT SwigClassWrapper _wrap_new_TpetraMultiVector__SWIG_6(SwigClassWrapper Tpetra::MultiVector< SC,LO,GO,NO > *result = 0 ; SWIG_check_sp_nonnull(farg1, "Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > *", "TpetraMultiVector", "Tpetra::MultiVector< SC,LO,GO,NO >::MultiVector(Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &,Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const &,size_t const)", return SwigClassWrapper_uninitialized()) - smartarg1 = static_cast< Teuchos::RCP >* >(farg1->ptr); - arg1 = const_cast*>(smartarg1->get()); + smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); + arg1 = const_cast< Tpetra::MultiVector* >(smartarg1->get()); SWIG_check_sp_nonnull(farg2, "Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type *", "TpetraMap", "Tpetra::MultiVector< SC,LO,GO,NO >::MultiVector(Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &,Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const &,size_t const)", return SwigClassWrapper_uninitialized()) - smartarg2 = static_cast< Teuchos::RCP >* >(farg2->ptr); - arg2 = const_cast*>(smartarg2->get()); - arg3 = *farg3; + smartarg2 = static_cast< Teuchos::RCP >* >(farg2->cptr); + arg2 = const_cast< Tpetra::Map* >(smartarg2->get()); + arg3 = static_cast< size_t >(*farg3); { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::MultiVector(Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &,Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const &,size_t const)");; @@ -3726,7 +3738,7 @@ SWIGEXPORT SwigClassWrapper _wrap_new_TpetraMultiVector__SWIG_6(SwigClassWrapper SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::MultiVector(Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &,Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const &,size_t const)", SWIG_UnknownError, "An unknown exception occurred", return SwigClassWrapper_uninitialized()); } } - fresult.ptr = result ? new Teuchos::RCP< Tpetra::MultiVector >(result SWIG_NO_NULL_DELETER_1) : NULL; + fresult.cptr = result ? new Teuchos::RCP< Tpetra::MultiVector >(result SWIG_NO_NULL_DELETER_1) : NULL; fresult.mem = SWIG_MOVE; return fresult; } @@ -3741,11 +3753,11 @@ SWIGEXPORT SwigClassWrapper _wrap_new_TpetraMultiVector__SWIG_7(SwigClassWrapper Tpetra::MultiVector< SC,LO,GO,NO > *result = 0 ; SWIG_check_sp_nonnull(farg1, "Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > *", "TpetraMultiVector", "Tpetra::MultiVector< SC,LO,GO,NO >::MultiVector(Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &,Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const &)", return SwigClassWrapper_uninitialized()) - smartarg1 = static_cast< Teuchos::RCP >* >(farg1->ptr); - arg1 = const_cast*>(smartarg1->get()); + smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); + arg1 = const_cast< Tpetra::MultiVector* >(smartarg1->get()); SWIG_check_sp_nonnull(farg2, "Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type *", "TpetraMap", "Tpetra::MultiVector< SC,LO,GO,NO >::MultiVector(Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &,Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const &)", return SwigClassWrapper_uninitialized()) - smartarg2 = static_cast< Teuchos::RCP >* >(farg2->ptr); - arg2 = const_cast*>(smartarg2->get()); + smartarg2 = static_cast< Teuchos::RCP >* >(farg2->cptr); + arg2 = const_cast< Tpetra::Map* >(smartarg2->get()); { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::MultiVector(Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &,Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const &)");; @@ -3769,7 +3781,7 @@ SWIGEXPORT SwigClassWrapper _wrap_new_TpetraMultiVector__SWIG_7(SwigClassWrapper SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::MultiVector(Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &,Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const &)", SWIG_UnknownError, "An unknown exception occurred", return SwigClassWrapper_uninitialized()); } } - fresult.ptr = result ? new Teuchos::RCP< Tpetra::MultiVector >(result SWIG_NO_NULL_DELETER_1) : NULL; + fresult.cptr = result ? new Teuchos::RCP< Tpetra::MultiVector >(result SWIG_NO_NULL_DELETER_1) : NULL; fresult.mem = SWIG_MOVE; return fresult; } @@ -3780,12 +3792,12 @@ SWIGEXPORT void _wrap_TpetraMultiVector_swap(SwigClassWrapper const *farg1, Swig Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > *arg2 = 0 ; Teuchos::RCP< Tpetra::MultiVector< SC,LO,GO,NO > > *smartarg1 ; Teuchos::RCP< Tpetra::MultiVector< SC,LO,GO,NO > > *smartarg2 ; - - smartarg1 = static_cast< Teuchos::RCP< Tpetra::MultiVector >* >(farg1->ptr); - arg1 = smartarg1 ? smartarg1->get() : NULL; + + smartarg1 = static_cast< Teuchos::RCP< Tpetra::MultiVector >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::MultiVector* >(smartarg1->get()) : NULL; SWIG_check_sp_nonnull(farg2, "Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > *", "TpetraMultiVector", "Tpetra::MultiVector< SC,LO,GO,NO >::swap(Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > &)", return ) - smartarg2 = static_cast< Teuchos::RCP< Tpetra::MultiVector >* >(farg2->ptr); - arg2 = smartarg2->get(); + smartarg2 = static_cast< Teuchos::RCP< Tpetra::MultiVector >* >(farg2->cptr); + arg2 = const_cast< Tpetra::MultiVector* >(smartarg2->get()); { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::swap(Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > &)");; @@ -3809,7 +3821,7 @@ SWIGEXPORT void _wrap_TpetraMultiVector_swap(SwigClassWrapper const *farg1, Swig SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::swap(Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > &)", SWIG_UnknownError, "An unknown exception occurred", return ); } } - + } @@ -3817,8 +3829,8 @@ SWIGEXPORT void _wrap_delete_TpetraMultiVector(SwigClassWrapper const *farg1) { Tpetra::MultiVector< SC,LO,GO,NO > *arg1 = (Tpetra::MultiVector< SC,LO,GO,NO > *) 0 ; Teuchos::RCP< Tpetra::MultiVector< SC,LO,GO,NO > > *smartarg1 ; - smartarg1 = static_cast< Teuchos::RCP< Tpetra::MultiVector >* >(farg1->ptr); - arg1 = smartarg1 ? smartarg1->get() : NULL; + smartarg1 = static_cast< Teuchos::RCP< Tpetra::MultiVector >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::MultiVector* >(smartarg1->get()) : NULL; { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::~MultiVector()");; @@ -3852,12 +3864,14 @@ SWIGEXPORT void _wrap_TpetraMultiVector_replaceGlobalValue(SwigClassWrapper cons size_t arg3 ; Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::impl_scalar_type *arg4 = 0 ; Teuchos::RCP< Tpetra::MultiVector< SC,LO,GO,NO > const > *smartarg1 ; + Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::impl_scalar_type temp4 ; - smartarg1 = static_cast< Teuchos::RCP >* >(farg1->ptr); - arg1 = smartarg1 ? const_cast*>(smartarg1->get()) : NULL; - arg2 = *farg2; + smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::MultiVector* >(smartarg1->get()) : NULL; + arg2 = static_cast< long long >(*farg2); arg3 = *farg3 - 1; - arg4 = reinterpret_cast< Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::impl_scalar_type * >(const_cast< double* >(farg4)); + temp4 = static_cast< Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::impl_scalar_type >(*farg4); + arg4 = &temp4; { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::replaceGlobalValue(long long const,size_t const,Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::impl_scalar_type const &) const");; @@ -3892,13 +3906,15 @@ SWIGEXPORT void _wrap_TpetraMultiVector_sumIntoGlobalValue__SWIG_0(SwigClassWrap Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::impl_scalar_type *arg4 = 0 ; bool arg5 ; Teuchos::RCP< Tpetra::MultiVector< SC,LO,GO,NO > const > *smartarg1 ; + Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::impl_scalar_type temp4 ; - smartarg1 = static_cast< Teuchos::RCP >* >(farg1->ptr); - arg1 = smartarg1 ? const_cast*>(smartarg1->get()) : NULL; - arg2 = *farg2; + smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::MultiVector* >(smartarg1->get()) : NULL; + arg2 = static_cast< long long >(*farg2); arg3 = *farg3 - 1; - arg4 = reinterpret_cast< Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::impl_scalar_type * >(const_cast< double* >(farg4)); - arg5 = *farg5; + temp4 = static_cast< Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::impl_scalar_type >(*farg4); + arg4 = &temp4; + arg5 = static_cast< bool >(*farg5); { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::sumIntoGlobalValue(long long const,size_t const,Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::impl_scalar_type const &,bool const) const");; @@ -3932,12 +3948,14 @@ SWIGEXPORT void _wrap_TpetraMultiVector_sumIntoGlobalValue__SWIG_1(SwigClassWrap size_t arg3 ; Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::impl_scalar_type *arg4 = 0 ; Teuchos::RCP< Tpetra::MultiVector< SC,LO,GO,NO > const > *smartarg1 ; + Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::impl_scalar_type temp4 ; - smartarg1 = static_cast< Teuchos::RCP >* >(farg1->ptr); - arg1 = smartarg1 ? const_cast*>(smartarg1->get()) : NULL; - arg2 = *farg2; + smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::MultiVector* >(smartarg1->get()) : NULL; + arg2 = static_cast< long long >(*farg2); arg3 = *farg3 - 1; - arg4 = reinterpret_cast< Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::impl_scalar_type * >(const_cast< double* >(farg4)); + temp4 = static_cast< Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::impl_scalar_type >(*farg4); + arg4 = &temp4; { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::sumIntoGlobalValue(long long const,size_t const,Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::impl_scalar_type const &) const");; @@ -3971,12 +3989,14 @@ SWIGEXPORT void _wrap_TpetraMultiVector_replaceLocalValue(SwigClassWrapper const size_t arg3 ; Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::impl_scalar_type *arg4 = 0 ; Teuchos::RCP< Tpetra::MultiVector< SC,LO,GO,NO > const > *smartarg1 ; + Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::impl_scalar_type temp4 ; - smartarg1 = static_cast< Teuchos::RCP >* >(farg1->ptr); - arg1 = smartarg1 ? const_cast*>(smartarg1->get()) : NULL; + smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::MultiVector* >(smartarg1->get()) : NULL; arg2 = *farg2 - 1; arg3 = *farg3 - 1; - arg4 = reinterpret_cast< Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::impl_scalar_type * >(const_cast< double* >(farg4)); + temp4 = static_cast< Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::impl_scalar_type >(*farg4); + arg4 = &temp4; { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::replaceLocalValue(int const,size_t const,Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::impl_scalar_type const &) const");; @@ -4011,13 +4031,15 @@ SWIGEXPORT void _wrap_TpetraMultiVector_sumIntoLocalValue__SWIG_0(SwigClassWrapp Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::impl_scalar_type *arg4 = 0 ; bool arg5 ; Teuchos::RCP< Tpetra::MultiVector< SC,LO,GO,NO > const > *smartarg1 ; + Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::impl_scalar_type temp4 ; - smartarg1 = static_cast< Teuchos::RCP >* >(farg1->ptr); - arg1 = smartarg1 ? const_cast*>(smartarg1->get()) : NULL; + smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::MultiVector* >(smartarg1->get()) : NULL; arg2 = *farg2 - 1; arg3 = *farg3 - 1; - arg4 = reinterpret_cast< Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::impl_scalar_type * >(const_cast< double* >(farg4)); - arg5 = *farg5; + temp4 = static_cast< Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::impl_scalar_type >(*farg4); + arg4 = &temp4; + arg5 = static_cast< bool >(*farg5); { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::sumIntoLocalValue(int const,size_t const,Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::impl_scalar_type const &,bool const) const");; @@ -4051,12 +4073,14 @@ SWIGEXPORT void _wrap_TpetraMultiVector_sumIntoLocalValue__SWIG_1(SwigClassWrapp size_t arg3 ; Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::impl_scalar_type *arg4 = 0 ; Teuchos::RCP< Tpetra::MultiVector< SC,LO,GO,NO > const > *smartarg1 ; + Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::impl_scalar_type temp4 ; - smartarg1 = static_cast< Teuchos::RCP >* >(farg1->ptr); - arg1 = smartarg1 ? const_cast*>(smartarg1->get()) : NULL; + smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::MultiVector* >(smartarg1->get()) : NULL; arg2 = *farg2 - 1; arg3 = *farg3 - 1; - arg4 = reinterpret_cast< Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::impl_scalar_type * >(const_cast< double* >(farg4)); + temp4 = static_cast< Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::impl_scalar_type >(*farg4); + arg4 = &temp4; { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::sumIntoLocalValue(int const,size_t const,Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::impl_scalar_type const &) const");; @@ -4088,10 +4112,12 @@ SWIGEXPORT void _wrap_TpetraMultiVector_putScalar(SwigClassWrapper const *farg1, Tpetra::MultiVector< SC,LO,GO,NO > *arg1 = (Tpetra::MultiVector< SC,LO,GO,NO > *) 0 ; double *arg2 = 0 ; Teuchos::RCP< Tpetra::MultiVector< SC,LO,GO,NO > > *smartarg1 ; + double temp2 ; - smartarg1 = static_cast< Teuchos::RCP< Tpetra::MultiVector >* >(farg1->ptr); - arg1 = smartarg1 ? smartarg1->get() : NULL; - arg2 = reinterpret_cast< double * >(const_cast< double* >(farg2)); + smartarg1 = static_cast< Teuchos::RCP< Tpetra::MultiVector >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::MultiVector* >(smartarg1->get()) : NULL; + temp2 = static_cast< double >(*farg2); + arg2 = &temp2; { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::putScalar(double const &)");; @@ -4123,8 +4149,8 @@ SWIGEXPORT void _wrap_TpetraMultiVector_randomize__SWIG_0(SwigClassWrapper const Tpetra::MultiVector< SC,LO,GO,NO > *arg1 = (Tpetra::MultiVector< SC,LO,GO,NO > *) 0 ; Teuchos::RCP< Tpetra::MultiVector< SC,LO,GO,NO > > *smartarg1 ; - smartarg1 = static_cast< Teuchos::RCP< Tpetra::MultiVector >* >(farg1->ptr); - arg1 = smartarg1 ? smartarg1->get() : NULL; + smartarg1 = static_cast< Teuchos::RCP< Tpetra::MultiVector >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::MultiVector* >(smartarg1->get()) : NULL; { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::randomize()");; @@ -4157,11 +4183,15 @@ SWIGEXPORT void _wrap_TpetraMultiVector_randomize__SWIG_1(SwigClassWrapper const double *arg2 = 0 ; double *arg3 = 0 ; Teuchos::RCP< Tpetra::MultiVector< SC,LO,GO,NO > > *smartarg1 ; + double temp2 ; + double temp3 ; - smartarg1 = static_cast< Teuchos::RCP< Tpetra::MultiVector >* >(farg1->ptr); - arg1 = smartarg1 ? smartarg1->get() : NULL; - arg2 = reinterpret_cast< double * >(const_cast< double* >(farg2)); - arg3 = reinterpret_cast< double * >(const_cast< double* >(farg3)); + smartarg1 = static_cast< Teuchos::RCP< Tpetra::MultiVector >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::MultiVector* >(smartarg1->get()) : NULL; + temp2 = static_cast< double >(*farg2); + arg2 = &temp2; + temp3 = static_cast< double >(*farg3); + arg3 = &temp3; { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::randomize(double const &,double const &)");; @@ -4195,9 +4225,9 @@ SWIGEXPORT void _wrap_TpetraMultiVector_replaceMap(SwigClassWrapper const *farg1 Teuchos::RCP< Tpetra::MultiVector< SC,LO,GO,NO > > *smartarg1 ; Teuchos::RCP< Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > tempnull2 ; - smartarg1 = static_cast< Teuchos::RCP< Tpetra::MultiVector >* >(farg1->ptr); - arg1 = smartarg1 ? smartarg1->get() : NULL; - arg2 = farg2->ptr ? static_cast< Teuchos::RCP< Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg2->ptr) : &tempnull2; + smartarg1 = static_cast< Teuchos::RCP< Tpetra::MultiVector >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::MultiVector* >(smartarg1->get()) : NULL; + arg2 = farg2->cptr ? static_cast< Teuchos::RCP< Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg2->cptr) : &tempnull2; { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::replaceMap(Teuchos::RCP< Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &)");; @@ -4229,8 +4259,8 @@ SWIGEXPORT void _wrap_TpetraMultiVector_reduce(SwigClassWrapper const *farg1) { Tpetra::MultiVector< SC,LO,GO,NO > *arg1 = (Tpetra::MultiVector< SC,LO,GO,NO > *) 0 ; Teuchos::RCP< Tpetra::MultiVector< SC,LO,GO,NO > > *smartarg1 ; - smartarg1 = static_cast< Teuchos::RCP< Tpetra::MultiVector >* >(farg1->ptr); - arg1 = smartarg1 ? smartarg1->get() : NULL; + smartarg1 = static_cast< Teuchos::RCP< Tpetra::MultiVector >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::MultiVector* >(smartarg1->get()) : NULL; { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::reduce()");; @@ -4267,10 +4297,10 @@ SWIGEXPORT SwigClassWrapper _wrap_TpetraMultiVector_offsetView(SwigClassWrapper Teuchos::RCP< Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > tempnull2 ; Teuchos::RCP< Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const > result; - smartarg1 = static_cast< Teuchos::RCP >* >(farg1->ptr); - arg1 = smartarg1 ? const_cast*>(smartarg1->get()) : NULL; - arg2 = farg2->ptr ? static_cast< Teuchos::RCP< Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg2->ptr) : &tempnull2; - arg3 = *farg3; + smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::MultiVector* >(smartarg1->get()) : NULL; + arg2 = farg2->cptr ? static_cast< Teuchos::RCP< Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg2->cptr) : &tempnull2; + arg3 = static_cast< size_t >(*farg3); { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::offsetView(Teuchos::RCP< Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,size_t const) const");; @@ -4294,7 +4324,7 @@ SWIGEXPORT SwigClassWrapper _wrap_TpetraMultiVector_offsetView(SwigClassWrapper SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::offsetView(Teuchos::RCP< Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,size_t const) const", SWIG_UnknownError, "An unknown exception occurred", return SwigClassWrapper_uninitialized()); } } - fresult.ptr = (new Teuchos::RCP >(static_cast< const Teuchos::RCP >& >(result))); + fresult.cptr = (new Teuchos::RCP >(static_cast< const Teuchos::RCP >& >(result))); fresult.mem = SWIG_MOVE; return fresult; } @@ -4309,10 +4339,10 @@ SWIGEXPORT SwigClassWrapper _wrap_TpetraMultiVector_offsetViewNonConst(SwigClass Teuchos::RCP< Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > tempnull2 ; Teuchos::RCP< Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > > result; - smartarg1 = static_cast< Teuchos::RCP< Tpetra::MultiVector >* >(farg1->ptr); - arg1 = smartarg1 ? smartarg1->get() : NULL; - arg2 = farg2->ptr ? static_cast< Teuchos::RCP< Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg2->ptr) : &tempnull2; - arg3 = *farg3; + smartarg1 = static_cast< Teuchos::RCP< Tpetra::MultiVector >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::MultiVector* >(smartarg1->get()) : NULL; + arg2 = farg2->cptr ? static_cast< Teuchos::RCP< Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg2->cptr) : &tempnull2; + arg3 = static_cast< size_t >(*farg3); { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::offsetViewNonConst(Teuchos::RCP< Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,size_t const)");; @@ -4336,7 +4366,7 @@ SWIGEXPORT SwigClassWrapper _wrap_TpetraMultiVector_offsetViewNonConst(SwigClass SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::offsetViewNonConst(Teuchos::RCP< Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,size_t const)", SWIG_UnknownError, "An unknown exception occurred", return SwigClassWrapper_uninitialized()); } } - fresult.ptr = (new Teuchos::RCP< Tpetra::MultiVector >(static_cast< const Teuchos::RCP< Tpetra::MultiVector >& >(result))); + fresult.cptr = (new Teuchos::RCP< Tpetra::MultiVector >(static_cast< const Teuchos::RCP< Tpetra::MultiVector >& >(result))); fresult.mem = SWIG_MOVE; return fresult; } @@ -4346,8 +4376,8 @@ SWIGEXPORT void _wrap_TpetraMultiVector_sync_host(SwigClassWrapper const *farg1) Tpetra::MultiVector< SC,LO,GO,NO > *arg1 = (Tpetra::MultiVector< SC,LO,GO,NO > *) 0 ; Teuchos::RCP< Tpetra::MultiVector< SC,LO,GO,NO > > *smartarg1 ; - smartarg1 = static_cast< Teuchos::RCP< Tpetra::MultiVector >* >(farg1->ptr); - arg1 = smartarg1 ? smartarg1->get() : NULL; + smartarg1 = static_cast< Teuchos::RCP< Tpetra::MultiVector >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::MultiVector* >(smartarg1->get()) : NULL; { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::sync_host()");; @@ -4379,8 +4409,8 @@ SWIGEXPORT void _wrap_TpetraMultiVector_sync_device(SwigClassWrapper const *farg Tpetra::MultiVector< SC,LO,GO,NO > *arg1 = (Tpetra::MultiVector< SC,LO,GO,NO > *) 0 ; Teuchos::RCP< Tpetra::MultiVector< SC,LO,GO,NO > > *smartarg1 ; - smartarg1 = static_cast< Teuchos::RCP< Tpetra::MultiVector >* >(farg1->ptr); - arg1 = smartarg1 ? smartarg1->get() : NULL; + smartarg1 = static_cast< Teuchos::RCP< Tpetra::MultiVector >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::MultiVector* >(smartarg1->get()) : NULL; { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::sync_device()");; @@ -4414,8 +4444,8 @@ SWIGEXPORT bool _wrap_TpetraMultiVector_need_sync_host(SwigClassWrapper const *f Teuchos::RCP< Tpetra::MultiVector< SC,LO,GO,NO > const > *smartarg1 ; bool result; - smartarg1 = static_cast< Teuchos::RCP >* >(farg1->ptr); - arg1 = smartarg1 ? const_cast*>(smartarg1->get()) : NULL; + smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::MultiVector* >(smartarg1->get()) : NULL; { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::need_sync_host() const");; @@ -4439,7 +4469,7 @@ SWIGEXPORT bool _wrap_TpetraMultiVector_need_sync_host(SwigClassWrapper const *f SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::need_sync_host() const", SWIG_UnknownError, "An unknown exception occurred", return 0); } } - fresult = result; + fresult = static_cast< bool >(result); return fresult; } @@ -4450,8 +4480,8 @@ SWIGEXPORT bool _wrap_TpetraMultiVector_need_sync_device(SwigClassWrapper const Teuchos::RCP< Tpetra::MultiVector< SC,LO,GO,NO > const > *smartarg1 ; bool result; - smartarg1 = static_cast< Teuchos::RCP >* >(farg1->ptr); - arg1 = smartarg1 ? const_cast*>(smartarg1->get()) : NULL; + smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::MultiVector* >(smartarg1->get()) : NULL; { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::need_sync_device() const");; @@ -4475,7 +4505,7 @@ SWIGEXPORT bool _wrap_TpetraMultiVector_need_sync_device(SwigClassWrapper const SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::need_sync_device() const", SWIG_UnknownError, "An unknown exception occurred", return 0); } } - fresult = result; + fresult = static_cast< bool >(result); return fresult; } @@ -4484,8 +4514,8 @@ SWIGEXPORT void _wrap_TpetraMultiVector_modify_device(SwigClassWrapper const *fa Tpetra::MultiVector< SC,LO,GO,NO > *arg1 = (Tpetra::MultiVector< SC,LO,GO,NO > *) 0 ; Teuchos::RCP< Tpetra::MultiVector< SC,LO,GO,NO > > *smartarg1 ; - smartarg1 = static_cast< Teuchos::RCP< Tpetra::MultiVector >* >(farg1->ptr); - arg1 = smartarg1 ? smartarg1->get() : NULL; + smartarg1 = static_cast< Teuchos::RCP< Tpetra::MultiVector >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::MultiVector* >(smartarg1->get()) : NULL; { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::modify_device()");; @@ -4517,8 +4547,8 @@ SWIGEXPORT void _wrap_TpetraMultiVector_modify_host(SwigClassWrapper const *farg Tpetra::MultiVector< SC,LO,GO,NO > *arg1 = (Tpetra::MultiVector< SC,LO,GO,NO > *) 0 ; Teuchos::RCP< Tpetra::MultiVector< SC,LO,GO,NO > > *smartarg1 ; - smartarg1 = static_cast< Teuchos::RCP< Tpetra::MultiVector >* >(farg1->ptr); - arg1 = smartarg1 ? smartarg1->get() : NULL; + smartarg1 = static_cast< Teuchos::RCP< Tpetra::MultiVector >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::MultiVector* >(smartarg1->get()) : NULL; { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::modify_host()");; @@ -4552,11 +4582,11 @@ SWIGEXPORT void _wrap_TpetraMultiVector_abs(SwigClassWrapper const *farg1, SwigC Teuchos::RCP< Tpetra::MultiVector< SC,LO,GO,NO > > *smartarg1 ; Teuchos::RCP< Tpetra::MultiVector< SC,LO,GO,NO > const > *smartarg2 ; - smartarg1 = static_cast< Teuchos::RCP< Tpetra::MultiVector >* >(farg1->ptr); - arg1 = smartarg1 ? smartarg1->get() : NULL; + smartarg1 = static_cast< Teuchos::RCP< Tpetra::MultiVector >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::MultiVector* >(smartarg1->get()) : NULL; SWIG_check_sp_nonnull(farg2, "Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > *", "TpetraMultiVector", "Tpetra::MultiVector< SC,LO,GO,NO >::abs(Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &)", return ) - smartarg2 = static_cast< Teuchos::RCP >* >(farg2->ptr); - arg2 = const_cast*>(smartarg2->get()); + smartarg2 = static_cast< Teuchos::RCP >* >(farg2->cptr); + arg2 = const_cast< Tpetra::MultiVector* >(smartarg2->get()); { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::abs(Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &)");; @@ -4590,11 +4620,11 @@ SWIGEXPORT void _wrap_TpetraMultiVector_reciprocal(SwigClassWrapper const *farg1 Teuchos::RCP< Tpetra::MultiVector< SC,LO,GO,NO > > *smartarg1 ; Teuchos::RCP< Tpetra::MultiVector< SC,LO,GO,NO > const > *smartarg2 ; - smartarg1 = static_cast< Teuchos::RCP< Tpetra::MultiVector >* >(farg1->ptr); - arg1 = smartarg1 ? smartarg1->get() : NULL; + smartarg1 = static_cast< Teuchos::RCP< Tpetra::MultiVector >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::MultiVector* >(smartarg1->get()) : NULL; SWIG_check_sp_nonnull(farg2, "Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > *", "TpetraMultiVector", "Tpetra::MultiVector< SC,LO,GO,NO >::reciprocal(Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &)", return ) - smartarg2 = static_cast< Teuchos::RCP >* >(farg2->ptr); - arg2 = const_cast*>(smartarg2->get()); + smartarg2 = static_cast< Teuchos::RCP >* >(farg2->cptr); + arg2 = const_cast< Tpetra::MultiVector* >(smartarg2->get()); { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::reciprocal(Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &)");; @@ -4618,7 +4648,7 @@ SWIGEXPORT void _wrap_TpetraMultiVector_reciprocal(SwigClassWrapper const *farg1 SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::reciprocal(Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &)", SWIG_UnknownError, "An unknown exception occurred", return ); } } - + } @@ -4626,10 +4656,12 @@ SWIGEXPORT void _wrap_TpetraMultiVector_scale__SWIG_0(SwigClassWrapper const *fa Tpetra::MultiVector< SC,LO,GO,NO > *arg1 = (Tpetra::MultiVector< SC,LO,GO,NO > *) 0 ; double *arg2 = 0 ; Teuchos::RCP< Tpetra::MultiVector< SC,LO,GO,NO > > *smartarg1 ; + double temp2 ; - smartarg1 = static_cast< Teuchos::RCP< Tpetra::MultiVector >* >(farg1->ptr); - arg1 = smartarg1 ? smartarg1->get() : NULL; - arg2 = reinterpret_cast< double * >(const_cast< double* >(farg2)); + smartarg1 = static_cast< Teuchos::RCP< Tpetra::MultiVector >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::MultiVector* >(smartarg1->get()) : NULL; + temp2 = static_cast< double >(*farg2); + arg2 = &temp2; { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::scale(double const &)");; @@ -4653,7 +4685,7 @@ SWIGEXPORT void _wrap_TpetraMultiVector_scale__SWIG_0(SwigClassWrapper const *fa SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::scale(double const &)", SWIG_UnknownError, "An unknown exception occurred", return ); } } - + } @@ -4662,14 +4694,16 @@ SWIGEXPORT void _wrap_TpetraMultiVector_scale__SWIG_1(SwigClassWrapper const *fa double *arg2 = 0 ; Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > *arg3 = 0 ; Teuchos::RCP< Tpetra::MultiVector< SC,LO,GO,NO > > *smartarg1 ; + double temp2 ; Teuchos::RCP< Tpetra::MultiVector< SC,LO,GO,NO > const > *smartarg3 ; - smartarg1 = static_cast< Teuchos::RCP< Tpetra::MultiVector >* >(farg1->ptr); - arg1 = smartarg1 ? smartarg1->get() : NULL; - arg2 = reinterpret_cast< double * >(const_cast< double* >(farg2)); + smartarg1 = static_cast< Teuchos::RCP< Tpetra::MultiVector >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::MultiVector* >(smartarg1->get()) : NULL; + temp2 = static_cast< double >(*farg2); + arg2 = &temp2; SWIG_check_sp_nonnull(farg3, "Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > *", "TpetraMultiVector", "Tpetra::MultiVector< SC,LO,GO,NO >::scale(double const &,Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &)", return ) - smartarg3 = static_cast< Teuchos::RCP >* >(farg3->ptr); - arg3 = const_cast*>(smartarg3->get()); + smartarg3 = static_cast< Teuchos::RCP >* >(farg3->cptr); + arg3 = const_cast< Tpetra::MultiVector* >(smartarg3->get()); { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::scale(double const &,Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &)");; @@ -4693,7 +4727,7 @@ SWIGEXPORT void _wrap_TpetraMultiVector_scale__SWIG_1(SwigClassWrapper const *fa SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::scale(double const &,Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &)", SWIG_UnknownError, "An unknown exception occurred", return ); } } - + } @@ -4703,15 +4737,19 @@ SWIGEXPORT void _wrap_TpetraMultiVector_update__SWIG_0(SwigClassWrapper const *f Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > *arg3 = 0 ; double *arg4 = 0 ; Teuchos::RCP< Tpetra::MultiVector< SC,LO,GO,NO > > *smartarg1 ; + double temp2 ; Teuchos::RCP< Tpetra::MultiVector< SC,LO,GO,NO > const > *smartarg3 ; + double temp4 ; - smartarg1 = static_cast< Teuchos::RCP< Tpetra::MultiVector >* >(farg1->ptr); - arg1 = smartarg1 ? smartarg1->get() : NULL; - arg2 = reinterpret_cast< double * >(const_cast< double* >(farg2)); + smartarg1 = static_cast< Teuchos::RCP< Tpetra::MultiVector >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::MultiVector* >(smartarg1->get()) : NULL; + temp2 = static_cast< double >(*farg2); + arg2 = &temp2; SWIG_check_sp_nonnull(farg3, "Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > *", "TpetraMultiVector", "Tpetra::MultiVector< SC,LO,GO,NO >::update(double const &,Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &,double const &)", return ) - smartarg3 = static_cast< Teuchos::RCP >* >(farg3->ptr); - arg3 = const_cast*>(smartarg3->get()); - arg4 = reinterpret_cast< double * >(const_cast< double* >(farg4)); + smartarg3 = static_cast< Teuchos::RCP >* >(farg3->cptr); + arg3 = const_cast< Tpetra::MultiVector* >(smartarg3->get()); + temp4 = static_cast< double >(*farg4); + arg4 = &temp4; { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::update(double const &,Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &,double const &)");; @@ -4735,7 +4773,7 @@ SWIGEXPORT void _wrap_TpetraMultiVector_update__SWIG_0(SwigClassWrapper const *f SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::update(double const &,Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &,double const &)", SWIG_UnknownError, "An unknown exception occurred", return ); } } - + } @@ -4747,20 +4785,26 @@ SWIGEXPORT void _wrap_TpetraMultiVector_update__SWIG_1(SwigClassWrapper const *f Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > *arg5 = 0 ; double *arg6 = 0 ; Teuchos::RCP< Tpetra::MultiVector< SC,LO,GO,NO > > *smartarg1 ; + double temp2 ; Teuchos::RCP< Tpetra::MultiVector< SC,LO,GO,NO > const > *smartarg3 ; + double temp4 ; Teuchos::RCP< Tpetra::MultiVector< SC,LO,GO,NO > const > *smartarg5 ; + double temp6 ; - smartarg1 = static_cast< Teuchos::RCP< Tpetra::MultiVector >* >(farg1->ptr); - arg1 = smartarg1 ? smartarg1->get() : NULL; - arg2 = reinterpret_cast< double * >(const_cast< double* >(farg2)); + smartarg1 = static_cast< Teuchos::RCP< Tpetra::MultiVector >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::MultiVector* >(smartarg1->get()) : NULL; + temp2 = static_cast< double >(*farg2); + arg2 = &temp2; SWIG_check_sp_nonnull(farg3, "Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > *", "TpetraMultiVector", "Tpetra::MultiVector< SC,LO,GO,NO >::update(double const &,Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &,double const &,Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &,double const &)", return ) - smartarg3 = static_cast< Teuchos::RCP >* >(farg3->ptr); - arg3 = const_cast*>(smartarg3->get()); - arg4 = reinterpret_cast< double * >(const_cast< double* >(farg4)); + smartarg3 = static_cast< Teuchos::RCP >* >(farg3->cptr); + arg3 = const_cast< Tpetra::MultiVector* >(smartarg3->get()); + temp4 = static_cast< double >(*farg4); + arg4 = &temp4; SWIG_check_sp_nonnull(farg5, "Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > *", "TpetraMultiVector", "Tpetra::MultiVector< SC,LO,GO,NO >::update(double const &,Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &,double const &,Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &,double const &)", return ) - smartarg5 = static_cast< Teuchos::RCP >* >(farg5->ptr); - arg5 = const_cast*>(smartarg5->get()); - arg6 = reinterpret_cast< double * >(const_cast< double* >(farg6)); + smartarg5 = static_cast< Teuchos::RCP >* >(farg5->cptr); + arg5 = const_cast< Tpetra::MultiVector* >(smartarg5->get()); + temp6 = static_cast< double >(*farg6); + arg6 = &temp6; { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::update(double const &,Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &,double const &,Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &,double const &)");; @@ -4784,7 +4828,7 @@ SWIGEXPORT void _wrap_TpetraMultiVector_update__SWIG_1(SwigClassWrapper const *f SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::update(double const &,Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &,double const &,Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &,double const &)", SWIG_UnknownError, "An unknown exception occurred", return ); } } - + } @@ -4797,21 +4841,25 @@ SWIGEXPORT void _wrap_TpetraMultiVector_multiply(SwigClassWrapper const *farg1, Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > *arg6 = 0 ; double *arg7 = 0 ; Teuchos::RCP< Tpetra::MultiVector< SC,LO,GO,NO > > *smartarg1 ; + double temp4 ; Teuchos::RCP< Tpetra::MultiVector< SC,LO,GO,NO > const > *smartarg5 ; Teuchos::RCP< Tpetra::MultiVector< SC,LO,GO,NO > const > *smartarg6 ; + double temp7 ; - smartarg1 = static_cast< Teuchos::RCP< Tpetra::MultiVector >* >(farg1->ptr); - arg1 = smartarg1 ? smartarg1->get() : NULL; + smartarg1 = static_cast< Teuchos::RCP< Tpetra::MultiVector >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::MultiVector* >(smartarg1->get()) : NULL; arg2 = static_cast< Teuchos::ETransp >(*farg2); arg3 = static_cast< Teuchos::ETransp >(*farg3); - arg4 = reinterpret_cast< double * >(const_cast< double* >(farg4)); + temp4 = static_cast< double >(*farg4); + arg4 = &temp4; SWIG_check_sp_nonnull(farg5, "Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > *", "TpetraMultiVector", "Tpetra::MultiVector< SC,LO,GO,NO >::multiply(Teuchos::ETransp,Teuchos::ETransp,double const &,Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &,Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &,double const &)", return ) - smartarg5 = static_cast< Teuchos::RCP >* >(farg5->ptr); - arg5 = const_cast*>(smartarg5->get()); + smartarg5 = static_cast< Teuchos::RCP >* >(farg5->cptr); + arg5 = const_cast< Tpetra::MultiVector* >(smartarg5->get()); SWIG_check_sp_nonnull(farg6, "Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > *", "TpetraMultiVector", "Tpetra::MultiVector< SC,LO,GO,NO >::multiply(Teuchos::ETransp,Teuchos::ETransp,double const &,Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &,Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &,double const &)", return ) - smartarg6 = static_cast< Teuchos::RCP >* >(farg6->ptr); - arg6 = const_cast*>(smartarg6->get()); - arg7 = reinterpret_cast< double * >(const_cast< double* >(farg7)); + smartarg6 = static_cast< Teuchos::RCP >* >(farg6->cptr); + arg6 = const_cast< Tpetra::MultiVector* >(smartarg6->get()); + temp7 = static_cast< double >(*farg7); + arg7 = &temp7; { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::multiply(Teuchos::ETransp,Teuchos::ETransp,double const &,Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &,Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &,double const &)");; @@ -4835,7 +4883,7 @@ SWIGEXPORT void _wrap_TpetraMultiVector_multiply(SwigClassWrapper const *farg1, SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::multiply(Teuchos::ETransp,Teuchos::ETransp,double const &,Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &,Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &,double const &)", SWIG_UnknownError, "An unknown exception occurred", return ); } } - + } @@ -4845,8 +4893,8 @@ SWIGEXPORT size_t _wrap_TpetraMultiVector_getNumVectors(SwigClassWrapper const * Teuchos::RCP< Tpetra::MultiVector< SC,LO,GO,NO > const > *smartarg1 ; size_t result; - smartarg1 = static_cast< Teuchos::RCP >* >(farg1->ptr); - arg1 = smartarg1 ? const_cast*>(smartarg1->get()) : NULL; + smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::MultiVector* >(smartarg1->get()) : NULL; { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::getNumVectors() const");; @@ -4870,7 +4918,7 @@ SWIGEXPORT size_t _wrap_TpetraMultiVector_getNumVectors(SwigClassWrapper const * SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::getNumVectors() const", SWIG_UnknownError, "An unknown exception occurred", return 0); } } - fresult = result; + fresult = static_cast< size_t >(result); return fresult; } @@ -4881,8 +4929,8 @@ SWIGEXPORT size_t _wrap_TpetraMultiVector_getLocalLength(SwigClassWrapper const Teuchos::RCP< Tpetra::MultiVector< SC,LO,GO,NO > const > *smartarg1 ; size_t result; - smartarg1 = static_cast< Teuchos::RCP >* >(farg1->ptr); - arg1 = smartarg1 ? const_cast*>(smartarg1->get()) : NULL; + smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::MultiVector* >(smartarg1->get()) : NULL; { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::getLocalLength() const");; @@ -4906,19 +4954,19 @@ SWIGEXPORT size_t _wrap_TpetraMultiVector_getLocalLength(SwigClassWrapper const SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::getLocalLength() const", SWIG_UnknownError, "An unknown exception occurred", return 0); } } - fresult = result; + fresult = static_cast< size_t >(result); return fresult; } -SWIGEXPORT unsigned long _wrap_TpetraMultiVector_getGlobalLength(SwigClassWrapper const *farg1) { - unsigned long fresult ; +SWIGEXPORT long _wrap_TpetraMultiVector_getGlobalLength(SwigClassWrapper const *farg1) { + long fresult ; Tpetra::MultiVector< SC,LO,GO,NO > *arg1 = (Tpetra::MultiVector< SC,LO,GO,NO > *) 0 ; Teuchos::RCP< Tpetra::MultiVector< SC,LO,GO,NO > const > *smartarg1 ; Tpetra::global_size_t result; - smartarg1 = static_cast< Teuchos::RCP >* >(farg1->ptr); - arg1 = smartarg1 ? const_cast*>(smartarg1->get()) : NULL; + smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::MultiVector* >(smartarg1->get()) : NULL; { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::getGlobalLength() const");; @@ -4942,7 +4990,7 @@ SWIGEXPORT unsigned long _wrap_TpetraMultiVector_getGlobalLength(SwigClassWrappe SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::getGlobalLength() const", SWIG_UnknownError, "An unknown exception occurred", return 0); } } - fresult = result; + fresult = static_cast< Tpetra::global_size_t >(result); return fresult; } @@ -4953,8 +5001,8 @@ SWIGEXPORT size_t _wrap_TpetraMultiVector_getStride(SwigClassWrapper const *farg Teuchos::RCP< Tpetra::MultiVector< SC,LO,GO,NO > const > *smartarg1 ; size_t result; - smartarg1 = static_cast< Teuchos::RCP >* >(farg1->ptr); - arg1 = smartarg1 ? const_cast*>(smartarg1->get()) : NULL; + smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::MultiVector* >(smartarg1->get()) : NULL; { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::getStride() const");; @@ -4978,7 +5026,7 @@ SWIGEXPORT size_t _wrap_TpetraMultiVector_getStride(SwigClassWrapper const *farg SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::getStride() const", SWIG_UnknownError, "An unknown exception occurred", return 0); } } - fresult = result; + fresult = static_cast< size_t >(result); return fresult; } @@ -4989,8 +5037,8 @@ SWIGEXPORT bool _wrap_TpetraMultiVector_isConstantStride(SwigClassWrapper const Teuchos::RCP< Tpetra::MultiVector< SC,LO,GO,NO > const > *smartarg1 ; bool result; - smartarg1 = static_cast< Teuchos::RCP >* >(farg1->ptr); - arg1 = smartarg1 ? const_cast*>(smartarg1->get()) : NULL; + smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::MultiVector* >(smartarg1->get()) : NULL; { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::isConstantStride() const");; @@ -5014,7 +5062,7 @@ SWIGEXPORT bool _wrap_TpetraMultiVector_isConstantStride(SwigClassWrapper const SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::isConstantStride() const", SWIG_UnknownError, "An unknown exception occurred", return 0); } } - fresult = result; + fresult = static_cast< bool >(result); return fresult; } @@ -5025,8 +5073,8 @@ SWIGEXPORT SwigArrayWrapper _wrap_TpetraMultiVector_description(SwigClassWrapper Teuchos::RCP< Tpetra::MultiVector< SC,LO,GO,NO > const > *smartarg1 ; std::string result; - smartarg1 = static_cast< Teuchos::RCP >* >(farg1->ptr); - arg1 = smartarg1 ? const_cast*>(smartarg1->get()) : NULL; + smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::MultiVector* >(smartarg1->get()) : NULL; { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::description() const");; @@ -5067,9 +5115,9 @@ SWIGEXPORT void _wrap_TpetraMultiVector_removeEmptyProcessesInPlace(SwigClassWra Teuchos::RCP< Tpetra::MultiVector< SC,LO,GO,NO > > *smartarg1 ; Teuchos::RCP< Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > tempnull2 ; - smartarg1 = static_cast< Teuchos::RCP< Tpetra::MultiVector >* >(farg1->ptr); - arg1 = smartarg1 ? smartarg1->get() : NULL; - arg2 = farg2->ptr ? static_cast< Teuchos::RCP< Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg2->ptr) : &tempnull2; + smartarg1 = static_cast< Teuchos::RCP< Tpetra::MultiVector >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::MultiVector* >(smartarg1->get()) : NULL; + arg2 = farg2->cptr ? static_cast< Teuchos::RCP< Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg2->cptr) : &tempnull2; { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::removeEmptyProcessesInPlace(Teuchos::RCP< Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &)");; @@ -5093,7 +5141,7 @@ SWIGEXPORT void _wrap_TpetraMultiVector_removeEmptyProcessesInPlace(SwigClassWra SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::removeEmptyProcessesInPlace(Teuchos::RCP< Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &)", SWIG_UnknownError, "An unknown exception occurred", return ); } } - + } @@ -5102,8 +5150,8 @@ SWIGEXPORT void _wrap_TpetraMultiVector_setCopyOrView(SwigClassWrapper const *fa Teuchos::DataAccess arg2 ; Teuchos::RCP< Tpetra::MultiVector< SC,LO,GO,NO > > *smartarg1 ; - smartarg1 = static_cast< Teuchos::RCP< Tpetra::MultiVector >* >(farg1->ptr); - arg1 = smartarg1 ? smartarg1->get() : NULL; + smartarg1 = static_cast< Teuchos::RCP< Tpetra::MultiVector >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::MultiVector* >(smartarg1->get()) : NULL; arg2 = static_cast< Teuchos::DataAccess >(*farg2); { // Make sure no unhandled exceptions exist before performing a new action @@ -5128,7 +5176,7 @@ SWIGEXPORT void _wrap_TpetraMultiVector_setCopyOrView(SwigClassWrapper const *fa SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::setCopyOrView(Teuchos::DataAccess const)", SWIG_UnknownError, "An unknown exception occurred", return ); } } - + } @@ -5138,8 +5186,8 @@ SWIGEXPORT int _wrap_TpetraMultiVector_getCopyOrView(SwigClassWrapper const *far Teuchos::RCP< Tpetra::MultiVector< SC,LO,GO,NO > const > *smartarg1 ; Teuchos::DataAccess result; - smartarg1 = static_cast< Teuchos::RCP >* >(farg1->ptr); - arg1 = smartarg1 ? const_cast*>(smartarg1->get()) : NULL; + smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::MultiVector* >(smartarg1->get()) : NULL; { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::getCopyOrView() const");; @@ -5176,11 +5224,11 @@ SWIGEXPORT bool _wrap_TpetraMultiVector_isSameSize(SwigClassWrapper const *farg1 Teuchos::RCP< Tpetra::MultiVector< SC,LO,GO,NO > const > *smartarg2 ; bool result; - smartarg1 = static_cast< Teuchos::RCP >* >(farg1->ptr); - arg1 = smartarg1 ? const_cast*>(smartarg1->get()) : NULL; + smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::MultiVector* >(smartarg1->get()) : NULL; SWIG_check_sp_nonnull(farg2, "Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > *", "TpetraMultiVector", "Tpetra::MultiVector< SC,LO,GO,NO >::isSameSize(Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &) const", return 0) - smartarg2 = static_cast< Teuchos::RCP >* >(farg2->ptr); - arg2 = const_cast*>(smartarg2->get()); + smartarg2 = static_cast< Teuchos::RCP >* >(farg2->cptr); + arg2 = const_cast< Tpetra::MultiVector* >(smartarg2->get()); { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::isSameSize(Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &) const");; @@ -5204,7 +5252,7 @@ SWIGEXPORT bool _wrap_TpetraMultiVector_isSameSize(SwigClassWrapper const *farg1 SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::isSameSize(Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &) const", SWIG_UnknownError, "An unknown exception occurred", return 0); } } - fresult = result; + fresult = static_cast< bool >(result); return fresult; } @@ -5218,11 +5266,11 @@ SWIGEXPORT SwigClassWrapper _wrap_new_TpetraMultiVector__SWIG_8(SwigClassWrapper Teuchos::RCP< Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > tempnull1 ; Tpetra::MultiVector< SC,LO,GO,NO > *result = 0 ; - arg1 = farg1->ptr ? static_cast< Teuchos::RCP< Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg1->ptr) : &tempnull1; + arg1 = farg1->cptr ? static_cast< Teuchos::RCP< Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg1->cptr) : &tempnull1; (&arg2)->first = static_cast(farg2->data); (&arg2)->second = farg2->size; - arg3 = *farg3; - arg4 = *farg4; + arg3 = static_cast< size_t >(*farg3); + arg4 = static_cast< size_t >(*farg4); { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::MultiVector(Teuchos::RCP< Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,std::pair< SC const *,std::size_t >,size_t const,size_t const)");; @@ -5246,7 +5294,7 @@ SWIGEXPORT SwigClassWrapper _wrap_new_TpetraMultiVector__SWIG_8(SwigClassWrapper SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::MultiVector(Teuchos::RCP< Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,std::pair< SC const *,std::size_t >,size_t const,size_t const)", SWIG_UnknownError, "An unknown exception occurred", return SwigClassWrapper_uninitialized()); } } - fresult.ptr = result ? new Teuchos::RCP< Tpetra::MultiVector >(result SWIG_NO_NULL_DELETER_1) : NULL; + fresult.cptr = result ? new Teuchos::RCP< Tpetra::MultiVector >(result SWIG_NO_NULL_DELETER_1) : NULL; fresult.mem = SWIG_MOVE; return fresult; } @@ -5259,8 +5307,8 @@ SWIGEXPORT SwigArrayWrapper _wrap_TpetraMultiVector_getData(SwigClassWrapper con Teuchos::RCP< Tpetra::MultiVector< SC,LO,GO,NO > const > *smartarg1 ; std::pair< SC const *,std::size_t > result; - smartarg1 = static_cast< Teuchos::RCP >* >(farg1->ptr); - arg1 = smartarg1 ? const_cast*>(smartarg1->get()) : NULL; + smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::MultiVector* >(smartarg1->get()) : NULL; arg2 = *farg2 - 1; { // Make sure no unhandled exceptions exist before performing a new action @@ -5298,8 +5346,8 @@ SWIGEXPORT SwigArrayWrapper _wrap_TpetraMultiVector_getDataNonConst(SwigClassWra Teuchos::RCP< Tpetra::MultiVector< SC,LO,GO,NO > > *smartarg1 ; std::pair< SC *,std::size_t > result; - smartarg1 = static_cast< Teuchos::RCP< Tpetra::MultiVector >* >(farg1->ptr); - arg1 = smartarg1 ? smartarg1->get() : NULL; + smartarg1 = static_cast< Teuchos::RCP< Tpetra::MultiVector >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::MultiVector* >(smartarg1->get()) : NULL; arg2 = *farg2 - 1; { // Make sure no unhandled exceptions exist before performing a new action @@ -5337,8 +5385,8 @@ SWIGEXPORT SwigClassWrapper _wrap_TpetraMultiVector_subCopy(SwigClassWrapper con Teuchos::RCP< Tpetra::MultiVector< SC,LO,GO,NO > const > *smartarg1 ; Teuchos::RCP< Tpetra::MultiVector< SC,LO,GO,NO > > result; - smartarg1 = static_cast< Teuchos::RCP >* >(farg1->ptr); - arg1 = smartarg1 ? const_cast*>(smartarg1->get()) : NULL; + smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::MultiVector* >(smartarg1->get()) : NULL; (&arg2)->first = static_cast(farg2->data); (&arg2)->second = farg2->size; { @@ -5364,7 +5412,7 @@ SWIGEXPORT SwigClassWrapper _wrap_TpetraMultiVector_subCopy(SwigClassWrapper con SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::subCopy(std::pair< std::size_t const *,std::size_t >) const", SWIG_UnknownError, "An unknown exception occurred", return SwigClassWrapper_uninitialized()); } } - fresult.ptr = (new Teuchos::RCP< Tpetra::MultiVector >(static_cast< const Teuchos::RCP< Tpetra::MultiVector >& >(result))); + fresult.cptr = (new Teuchos::RCP< Tpetra::MultiVector >(static_cast< const Teuchos::RCP< Tpetra::MultiVector >& >(result))); fresult.mem = SWIG_MOVE; return fresult; } @@ -5377,8 +5425,8 @@ SWIGEXPORT SwigClassWrapper _wrap_TpetraMultiVector_subView(SwigClassWrapper con Teuchos::RCP< Tpetra::MultiVector< SC,LO,GO,NO > const > *smartarg1 ; Teuchos::RCP< Tpetra::MultiVector< SC,LO,GO,NO > const > result; - smartarg1 = static_cast< Teuchos::RCP >* >(farg1->ptr); - arg1 = smartarg1 ? const_cast*>(smartarg1->get()) : NULL; + smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::MultiVector* >(smartarg1->get()) : NULL; (&arg2)->first = static_cast(farg2->data); (&arg2)->second = farg2->size; { @@ -5404,7 +5452,7 @@ SWIGEXPORT SwigClassWrapper _wrap_TpetraMultiVector_subView(SwigClassWrapper con SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::subView(std::pair< std::size_t const *,std::size_t >) const", SWIG_UnknownError, "An unknown exception occurred", return SwigClassWrapper_uninitialized()); } } - fresult.ptr = (new Teuchos::RCP >(static_cast< const Teuchos::RCP >& >(result))); + fresult.cptr = (new Teuchos::RCP >(static_cast< const Teuchos::RCP >& >(result))); fresult.mem = SWIG_MOVE; return fresult; } @@ -5417,8 +5465,8 @@ SWIGEXPORT SwigClassWrapper _wrap_TpetraMultiVector_subViewNonConst(SwigClassWra Teuchos::RCP< Tpetra::MultiVector< SC,LO,GO,NO > > *smartarg1 ; Teuchos::RCP< Tpetra::MultiVector< SC,LO,GO,NO > > result; - smartarg1 = static_cast< Teuchos::RCP< Tpetra::MultiVector >* >(farg1->ptr); - arg1 = smartarg1 ? smartarg1->get() : NULL; + smartarg1 = static_cast< Teuchos::RCP< Tpetra::MultiVector >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::MultiVector* >(smartarg1->get()) : NULL; (&arg2)->first = static_cast(farg2->data); (&arg2)->second = farg2->size; { @@ -5444,7 +5492,7 @@ SWIGEXPORT SwigClassWrapper _wrap_TpetraMultiVector_subViewNonConst(SwigClassWra SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::subViewNonConst(std::pair< std::size_t const *,std::size_t >)", SWIG_UnknownError, "An unknown exception occurred", return SwigClassWrapper_uninitialized()); } } - fresult.ptr = (new Teuchos::RCP< Tpetra::MultiVector >(static_cast< const Teuchos::RCP< Tpetra::MultiVector >& >(result))); + fresult.cptr = (new Teuchos::RCP< Tpetra::MultiVector >(static_cast< const Teuchos::RCP< Tpetra::MultiVector >& >(result))); fresult.mem = SWIG_MOVE; return fresult; } @@ -5457,11 +5505,11 @@ SWIGEXPORT void _wrap_TpetraMultiVector_dot(SwigClassWrapper const *farg1, SwigC Teuchos::RCP< Tpetra::MultiVector< SC,LO,GO,NO > const > *smartarg1 ; Teuchos::RCP< Tpetra::MultiVector< SC,LO,GO,NO > const > *smartarg2 ; - smartarg1 = static_cast< Teuchos::RCP >* >(farg1->ptr); - arg1 = smartarg1 ? const_cast*>(smartarg1->get()) : NULL; + smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::MultiVector* >(smartarg1->get()) : NULL; SWIG_check_sp_nonnull(farg2, "Tpetra::MultiVector< SC,LO,GO,NO > *", "TpetraMultiVector", "Tpetra::MultiVector< SC,LO,GO,NO >::dot(Tpetra::MultiVector< SC,LO,GO,NO > const &,std::pair< SC *,std::size_t >) const", return ) - smartarg2 = static_cast< Teuchos::RCP >* >(farg2->ptr); - arg2 = const_cast*>(smartarg2->get()); + smartarg2 = static_cast< Teuchos::RCP >* >(farg2->cptr); + arg2 = const_cast< Tpetra::MultiVector* >(smartarg2->get()); (&arg3)->first = static_cast(farg3->data); (&arg3)->second = farg3->size; { @@ -5487,7 +5535,7 @@ SWIGEXPORT void _wrap_TpetraMultiVector_dot(SwigClassWrapper const *farg1, SwigC SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::dot(Tpetra::MultiVector< SC,LO,GO,NO > const &,std::pair< SC *,std::size_t >) const", SWIG_UnknownError, "An unknown exception occurred", return ); } } - + } @@ -5496,8 +5544,8 @@ SWIGEXPORT void _wrap_TpetraMultiVector_norm1(SwigClassWrapper const *farg1, Swi std::pair< SC *,std::size_t > arg2 ; Teuchos::RCP< Tpetra::MultiVector< SC,LO,GO,NO > const > *smartarg1 ; - smartarg1 = static_cast< Teuchos::RCP >* >(farg1->ptr); - arg1 = smartarg1 ? const_cast*>(smartarg1->get()) : NULL; + smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::MultiVector* >(smartarg1->get()) : NULL; (&arg2)->first = static_cast(farg2->data); (&arg2)->second = farg2->size; { @@ -5523,7 +5571,7 @@ SWIGEXPORT void _wrap_TpetraMultiVector_norm1(SwigClassWrapper const *farg1, Swi SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::norm1(std::pair< SC *,std::size_t >) const", SWIG_UnknownError, "An unknown exception occurred", return ); } } - + } @@ -5531,9 +5579,9 @@ SWIGEXPORT void _wrap_TpetraMultiVector_norm2(SwigClassWrapper const *farg1, Swi Tpetra::MultiVector< SC,LO,GO,NO > *arg1 = (Tpetra::MultiVector< SC,LO,GO,NO > *) 0 ; std::pair< SC *,std::size_t > arg2 ; Teuchos::RCP< Tpetra::MultiVector< SC,LO,GO,NO > const > *smartarg1 ; - - smartarg1 = static_cast< Teuchos::RCP >* >(farg1->ptr); - arg1 = smartarg1 ? const_cast*>(smartarg1->get()) : NULL; + + smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::MultiVector* >(smartarg1->get()) : NULL; (&arg2)->first = static_cast(farg2->data); (&arg2)->second = farg2->size; { @@ -5559,7 +5607,7 @@ SWIGEXPORT void _wrap_TpetraMultiVector_norm2(SwigClassWrapper const *farg1, Swi SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::norm2(std::pair< SC *,std::size_t >) const", SWIG_UnknownError, "An unknown exception occurred", return ); } } - + } @@ -5567,9 +5615,9 @@ SWIGEXPORT void _wrap_TpetraMultiVector_normInf(SwigClassWrapper const *farg1, S Tpetra::MultiVector< SC,LO,GO,NO > *arg1 = (Tpetra::MultiVector< SC,LO,GO,NO > *) 0 ; std::pair< SC *,std::size_t > arg2 ; Teuchos::RCP< Tpetra::MultiVector< SC,LO,GO,NO > const > *smartarg1 ; - - smartarg1 = static_cast< Teuchos::RCP >* >(farg1->ptr); - arg1 = smartarg1 ? const_cast*>(smartarg1->get()) : NULL; + + smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::MultiVector* >(smartarg1->get()) : NULL; (&arg2)->first = static_cast(farg2->data); (&arg2)->second = farg2->size; { @@ -5595,7 +5643,7 @@ SWIGEXPORT void _wrap_TpetraMultiVector_normInf(SwigClassWrapper const *farg1, S SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::normInf(std::pair< SC *,std::size_t >) const", SWIG_UnknownError, "An unknown exception occurred", return ); } } - + } @@ -5603,9 +5651,9 @@ SWIGEXPORT void _wrap_TpetraMultiVector_scale__SWIG_2(SwigClassWrapper const *fa Tpetra::MultiVector< SC,LO,GO,NO > *arg1 = (Tpetra::MultiVector< SC,LO,GO,NO > *) 0 ; std::pair< SC const *,std::size_t > arg2 ; Teuchos::RCP< Tpetra::MultiVector< SC,LO,GO,NO > > *smartarg1 ; - - smartarg1 = static_cast< Teuchos::RCP< Tpetra::MultiVector >* >(farg1->ptr); - arg1 = smartarg1 ? smartarg1->get() : NULL; + + smartarg1 = static_cast< Teuchos::RCP< Tpetra::MultiVector >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::MultiVector* >(smartarg1->get()) : NULL; (&arg2)->first = static_cast(farg2->data); (&arg2)->second = farg2->size; { @@ -5631,7 +5679,7 @@ SWIGEXPORT void _wrap_TpetraMultiVector_scale__SWIG_2(SwigClassWrapper const *fa SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::scale(std::pair< SC const *,std::size_t >)", SWIG_UnknownError, "An unknown exception occurred", return ); } } - + } @@ -5639,9 +5687,9 @@ SWIGEXPORT void _wrap_TpetraMultiVector_meanValue(SwigClassWrapper const *farg1, Tpetra::MultiVector< SC,LO,GO,NO > *arg1 = (Tpetra::MultiVector< SC,LO,GO,NO > *) 0 ; std::pair< SC *,std::size_t > arg2 ; Teuchos::RCP< Tpetra::MultiVector< SC,LO,GO,NO > const > *smartarg1 ; - - smartarg1 = static_cast< Teuchos::RCP >* >(farg1->ptr); - arg1 = smartarg1 ? const_cast*>(smartarg1->get()) : NULL; + + smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::MultiVector* >(smartarg1->get()) : NULL; (&arg2)->first = static_cast(farg2->data); (&arg2)->second = farg2->size; { @@ -5667,7 +5715,7 @@ SWIGEXPORT void _wrap_TpetraMultiVector_meanValue(SwigClassWrapper const *farg1, SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::meanValue(std::pair< SC *,std::size_t >) const", SWIG_UnknownError, "An unknown exception occurred", return ); } } - + } @@ -5676,12 +5724,12 @@ SWIGEXPORT void _wrap_TpetraMultiVector_get1dCopy(SwigClassWrapper const *farg1, std::pair< SC *,std::size_t > arg2 ; size_t arg3 ; Teuchos::RCP< Tpetra::MultiVector< SC,LO,GO,NO > const > *smartarg1 ; - - smartarg1 = static_cast< Teuchos::RCP >* >(farg1->ptr); - arg1 = smartarg1 ? const_cast*>(smartarg1->get()) : NULL; + + smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::MultiVector* >(smartarg1->get()) : NULL; (&arg2)->first = static_cast(farg2->data); (&arg2)->second = farg2->size; - arg3 = *farg3; + arg3 = static_cast< size_t >(*farg3); { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::get1dCopy(std::pair< SC *,std::size_t >,size_t const) const");; @@ -5705,7 +5753,7 @@ SWIGEXPORT void _wrap_TpetraMultiVector_get1dCopy(SwigClassWrapper const *farg1, SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::get1dCopy(std::pair< SC *,std::size_t >,size_t const) const", SWIG_UnknownError, "An unknown exception occurred", return ); } } - + } @@ -5714,9 +5762,9 @@ SWIGEXPORT SwigArrayWrapper _wrap_TpetraMultiVector_get1dView(SwigClassWrapper c Tpetra::MultiVector< SC,LO,GO,NO > *arg1 = (Tpetra::MultiVector< SC,LO,GO,NO > *) 0 ; Teuchos::RCP< Tpetra::MultiVector< SC,LO,GO,NO > const > *smartarg1 ; std::pair< SC const *,std::size_t > result; - - smartarg1 = static_cast< Teuchos::RCP >* >(farg1->ptr); - arg1 = smartarg1 ? const_cast*>(smartarg1->get()) : NULL; + + smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::MultiVector* >(smartarg1->get()) : NULL; { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::get1dView() const");; @@ -5751,9 +5799,9 @@ SWIGEXPORT SwigArrayWrapper _wrap_TpetraMultiVector_get1dViewNonConst(SwigClassW Tpetra::MultiVector< SC,LO,GO,NO > *arg1 = (Tpetra::MultiVector< SC,LO,GO,NO > *) 0 ; Teuchos::RCP< Tpetra::MultiVector< SC,LO,GO,NO > > *smartarg1 ; std::pair< SC *,std::size_t > result; - - smartarg1 = static_cast< Teuchos::RCP< Tpetra::MultiVector >* >(farg1->ptr); - arg1 = smartarg1 ? smartarg1->get() : NULL; + + smartarg1 = static_cast< Teuchos::RCP< Tpetra::MultiVector >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::MultiVector* >(smartarg1->get()) : NULL; { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::get1dViewNonConst()");; @@ -5792,14 +5840,14 @@ SWIGEXPORT void _wrap_TpetraMultiVector_doImport__SWIG_0(SwigClassWrapper const Teuchos::RCP< Tpetra::MultiVector< SC,LO,GO,NO > const > *smartarg2 ; Teuchos::RCP< Tpetra::Import< LO,GO,NO > const > *smartarg3 ; - smartarg1 = static_cast< Teuchos::RCP< Tpetra::MultiVector >* >(farg1->ptr); - arg1 = smartarg1 ? smartarg1->get() : NULL; + smartarg1 = static_cast< Teuchos::RCP< Tpetra::MultiVector >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::MultiVector* >(smartarg1->get()) : NULL; SWIG_check_sp_nonnull(farg2, "Tpetra::MultiVector< SC,LO,GO,NO > *", "TpetraMultiVector", "Tpetra::MultiVector< SC,LO,GO,NO >::doImport(Tpetra::MultiVector< SC,LO,GO,NO > const &,Tpetra::Import< LO,GO,NO > const &,Tpetra::CombineMode)", return ) - smartarg2 = static_cast< Teuchos::RCP >* >(farg2->ptr); - arg2 = const_cast*>(smartarg2->get()); + smartarg2 = static_cast< Teuchos::RCP >* >(farg2->cptr); + arg2 = const_cast< Tpetra::MultiVector* >(smartarg2->get()); SWIG_check_sp_nonnull(farg3, "Tpetra::Import< LO,GO,NO > *", "TpetraImport", "Tpetra::MultiVector< SC,LO,GO,NO >::doImport(Tpetra::MultiVector< SC,LO,GO,NO > const &,Tpetra::Import< LO,GO,NO > const &,Tpetra::CombineMode)", return ) - smartarg3 = static_cast< Teuchos::RCP >* >(farg3->ptr); - arg3 = const_cast*>(smartarg3->get()); + smartarg3 = static_cast< Teuchos::RCP >* >(farg3->cptr); + arg3 = const_cast< Tpetra::Import* >(smartarg3->get()); arg4 = static_cast< Tpetra::CombineMode >(*farg4); { // Make sure no unhandled exceptions exist before performing a new action @@ -5837,14 +5885,14 @@ SWIGEXPORT void _wrap_TpetraMultiVector_doImport__SWIG_1(SwigClassWrapper const Teuchos::RCP< Tpetra::MultiVector< SC,LO,GO,NO > const > *smartarg2 ; Teuchos::RCP< Tpetra::Export< LO,GO,NO > const > *smartarg3 ; - smartarg1 = static_cast< Teuchos::RCP< Tpetra::MultiVector >* >(farg1->ptr); - arg1 = smartarg1 ? smartarg1->get() : NULL; + smartarg1 = static_cast< Teuchos::RCP< Tpetra::MultiVector >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::MultiVector* >(smartarg1->get()) : NULL; SWIG_check_sp_nonnull(farg2, "Tpetra::MultiVector< SC,LO,GO,NO > *", "TpetraMultiVector", "Tpetra::MultiVector< SC,LO,GO,NO >::doImport(Tpetra::MultiVector< SC,LO,GO,NO > const &,Tpetra::Export< LO,GO,NO > const &,Tpetra::CombineMode)", return ) - smartarg2 = static_cast< Teuchos::RCP >* >(farg2->ptr); - arg2 = const_cast*>(smartarg2->get()); + smartarg2 = static_cast< Teuchos::RCP >* >(farg2->cptr); + arg2 = const_cast< Tpetra::MultiVector* >(smartarg2->get()); SWIG_check_sp_nonnull(farg3, "Tpetra::Export< LO,GO,NO > *", "TpetraExport", "Tpetra::MultiVector< SC,LO,GO,NO >::doImport(Tpetra::MultiVector< SC,LO,GO,NO > const &,Tpetra::Export< LO,GO,NO > const &,Tpetra::CombineMode)", return ) - smartarg3 = static_cast< Teuchos::RCP >* >(farg3->ptr); - arg3 = const_cast*>(smartarg3->get()); + smartarg3 = static_cast< Teuchos::RCP >* >(farg3->cptr); + arg3 = const_cast< Tpetra::Export* >(smartarg3->get()); arg4 = static_cast< Tpetra::CombineMode >(*farg4); { // Make sure no unhandled exceptions exist before performing a new action @@ -5882,14 +5930,14 @@ SWIGEXPORT void _wrap_TpetraMultiVector_doExport__SWIG_0(SwigClassWrapper const Teuchos::RCP< Tpetra::MultiVector< SC,LO,GO,NO > const > *smartarg2 ; Teuchos::RCP< Tpetra::Export< LO,GO,NO > const > *smartarg3 ; - smartarg1 = static_cast< Teuchos::RCP< Tpetra::MultiVector >* >(farg1->ptr); - arg1 = smartarg1 ? smartarg1->get() : NULL; + smartarg1 = static_cast< Teuchos::RCP< Tpetra::MultiVector >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::MultiVector* >(smartarg1->get()) : NULL; SWIG_check_sp_nonnull(farg2, "Tpetra::MultiVector< SC,LO,GO,NO > *", "TpetraMultiVector", "Tpetra::MultiVector< SC,LO,GO,NO >::doExport(Tpetra::MultiVector< SC,LO,GO,NO > const &,Tpetra::Export< LO,GO,NO > const &,Tpetra::CombineMode)", return ) - smartarg2 = static_cast< Teuchos::RCP >* >(farg2->ptr); - arg2 = const_cast*>(smartarg2->get()); + smartarg2 = static_cast< Teuchos::RCP >* >(farg2->cptr); + arg2 = const_cast< Tpetra::MultiVector* >(smartarg2->get()); SWIG_check_sp_nonnull(farg3, "Tpetra::Export< LO,GO,NO > *", "TpetraExport", "Tpetra::MultiVector< SC,LO,GO,NO >::doExport(Tpetra::MultiVector< SC,LO,GO,NO > const &,Tpetra::Export< LO,GO,NO > const &,Tpetra::CombineMode)", return ) - smartarg3 = static_cast< Teuchos::RCP >* >(farg3->ptr); - arg3 = const_cast*>(smartarg3->get()); + smartarg3 = static_cast< Teuchos::RCP >* >(farg3->cptr); + arg3 = const_cast< Tpetra::Export* >(smartarg3->get()); arg4 = static_cast< Tpetra::CombineMode >(*farg4); { // Make sure no unhandled exceptions exist before performing a new action @@ -5927,14 +5975,14 @@ SWIGEXPORT void _wrap_TpetraMultiVector_doExport__SWIG_1(SwigClassWrapper const Teuchos::RCP< Tpetra::MultiVector< SC,LO,GO,NO > const > *smartarg2 ; Teuchos::RCP< Tpetra::Import< LO,GO,NO > const > *smartarg3 ; - smartarg1 = static_cast< Teuchos::RCP< Tpetra::MultiVector >* >(farg1->ptr); - arg1 = smartarg1 ? smartarg1->get() : NULL; + smartarg1 = static_cast< Teuchos::RCP< Tpetra::MultiVector >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::MultiVector* >(smartarg1->get()) : NULL; SWIG_check_sp_nonnull(farg2, "Tpetra::MultiVector< SC,LO,GO,NO > *", "TpetraMultiVector", "Tpetra::MultiVector< SC,LO,GO,NO >::doExport(Tpetra::MultiVector< SC,LO,GO,NO > const &,Tpetra::Import< LO,GO,NO > const &,Tpetra::CombineMode)", return ) - smartarg2 = static_cast< Teuchos::RCP >* >(farg2->ptr); - arg2 = const_cast*>(smartarg2->get()); + smartarg2 = static_cast< Teuchos::RCP >* >(farg2->cptr); + arg2 = const_cast< Tpetra::MultiVector* >(smartarg2->get()); SWIG_check_sp_nonnull(farg3, "Tpetra::Import< LO,GO,NO > *", "TpetraImport", "Tpetra::MultiVector< SC,LO,GO,NO >::doExport(Tpetra::MultiVector< SC,LO,GO,NO > const &,Tpetra::Import< LO,GO,NO > const &,Tpetra::CombineMode)", return ) - smartarg3 = static_cast< Teuchos::RCP >* >(farg3->ptr); - arg3 = const_cast*>(smartarg3->get()); + smartarg3 = static_cast< Teuchos::RCP >* >(farg3->cptr); + arg3 = const_cast< Tpetra::Import* >(smartarg3->get()); arg4 = static_cast< Tpetra::CombineMode >(*farg4); { // Make sure no unhandled exceptions exist before performing a new action @@ -5969,8 +6017,8 @@ SWIGEXPORT SwigClassWrapper _wrap_TpetraMultiVector_getMap(SwigClassWrapper cons Teuchos::RCP< Tpetra::MultiVector< SC,LO,GO,NO > const > *smartarg1 ; Teuchos::RCP< Tpetra::Map< LO,GO,NO > const > result; - smartarg1 = static_cast< Teuchos::RCP >* >(farg1->ptr); - arg1 = smartarg1 ? const_cast*>(smartarg1->get()) : NULL; + smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::MultiVector* >(smartarg1->get()) : NULL; { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::getMap() const");; @@ -5994,14 +6042,14 @@ SWIGEXPORT SwigClassWrapper _wrap_TpetraMultiVector_getMap(SwigClassWrapper cons SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::getMap() const", SWIG_UnknownError, "An unknown exception occurred", return SwigClassWrapper_uninitialized()); } } - fresult.ptr = (new Teuchos::RCP >(static_cast< const Teuchos::RCP >& >(result))); + fresult.cptr = (new Teuchos::RCP >(static_cast< const Teuchos::RCP >& >(result))); fresult.mem = SWIG_MOVE; return fresult; } SWIGEXPORT void _wrap_assign_TpetraMultiVector(SwigClassWrapper * self, SwigClassWrapper const * other) { - typedef ::Teuchos::RCP< Tpetra::MultiVector > swig_lhs_classtype; + typedef Teuchos::RCP< Tpetra::MultiVector > swig_lhs_classtype; SWIG_assign(swig_lhs_classtype, self, swig_lhs_classtype, const_cast(other), 0 | swig::IS_DESTR | swig::IS_COPY_CONSTR | swig::IS_COPY_ASSIGN); @@ -6012,8 +6060,8 @@ SWIGEXPORT void _wrap_delete_TpetraOperator(SwigClassWrapper const *farg1) { Tpetra::Operator< SC,LO,GO,NO > *arg1 = (Tpetra::Operator< SC,LO,GO,NO > *) 0 ; Teuchos::RCP< Tpetra::Operator< SC,LO,GO,NO > > *smartarg1 ; - smartarg1 = static_cast< Teuchos::RCP< Tpetra::Operator >* >(farg1->ptr); - arg1 = smartarg1 ? smartarg1->get() : NULL; + smartarg1 = static_cast< Teuchos::RCP< Tpetra::Operator >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::Operator* >(smartarg1->get()) : NULL; { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::Operator< SC,LO,GO,NO >::~Operator()");; @@ -6042,7 +6090,7 @@ SWIGEXPORT void _wrap_delete_TpetraOperator(SwigClassWrapper const *farg1) { SWIGEXPORT void _wrap_assign_TpetraOperator(SwigClassWrapper * self, SwigClassWrapper const * other) { - typedef ::Teuchos::RCP< Tpetra::Operator > swig_lhs_classtype; + typedef Teuchos::RCP< Tpetra::Operator > swig_lhs_classtype; SWIG_assign(swig_lhs_classtype, self, swig_lhs_classtype, const_cast(other), 0 | swig::IS_DESTR | swig::IS_COPY_CONSTR); @@ -6055,8 +6103,8 @@ SWIGEXPORT void * _wrap_ForTpetraOperator_fhandle(SwigClassWrapper const *farg1) Teuchos::RCP< ForTpetraOperator const > *smartarg1 ; void *result = 0 ; - smartarg1 = static_cast< Teuchos::RCP* >(farg1->ptr); - arg1 = smartarg1 ? const_cast(smartarg1->get()) : NULL; + smartarg1 = static_cast< Teuchos::RCP* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< ForTpetraOperator* >(smartarg1->get()) : NULL; { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("ForTpetraOperator::fhandle() const");; @@ -6090,8 +6138,8 @@ SWIGEXPORT void _wrap_ForTpetraOperator_init(SwigClassWrapper const *farg1, void void *arg2 = (void *) 0 ; Teuchos::RCP< ForTpetraOperator > *smartarg1 ; - smartarg1 = static_cast< Teuchos::RCP< ForTpetraOperator >* >(farg1->ptr); - arg1 = smartarg1 ? smartarg1->get() : NULL; + smartarg1 = static_cast< Teuchos::RCP< ForTpetraOperator >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< ForTpetraOperator* >(smartarg1->get()) : NULL; arg2 = reinterpret_cast< void * >(farg2); { // Make sure no unhandled exceptions exist before performing a new action @@ -6147,7 +6195,7 @@ SWIGEXPORT SwigClassWrapper _wrap_new_ForTpetraOperator() { SWIG_exception_impl("ForTpetraOperator::ForTpetraOperator()", SWIG_UnknownError, "An unknown exception occurred", return SwigClassWrapper_uninitialized()); } } - fresult.ptr = result ? new Teuchos::RCP< ForTpetraOperator >(result SWIG_NO_NULL_DELETER_1) : NULL; + fresult.cptr = result ? new Teuchos::RCP< ForTpetraOperator >(result SWIG_NO_NULL_DELETER_1) : NULL; fresult.mem = SWIG_MOVE; return fresult; } @@ -6159,8 +6207,8 @@ SWIGEXPORT SwigClassWrapper _wrap_ForTpetraOperator_getDomainMap(SwigClassWrappe Teuchos::RCP< ForTpetraOperator const > *smartarg1 ; Teuchos::RCP< ForTpetraOperator::map_type const > result; - smartarg1 = static_cast< Teuchos::RCP* >(farg1->ptr); - arg1 = smartarg1 ? const_cast(smartarg1->get()) : NULL; + smartarg1 = static_cast< Teuchos::RCP* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< ForTpetraOperator* >(smartarg1->get()) : NULL; { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("ForTpetraOperator::getDomainMap() const");; @@ -6184,7 +6232,7 @@ SWIGEXPORT SwigClassWrapper _wrap_ForTpetraOperator_getDomainMap(SwigClassWrappe SWIG_exception_impl("ForTpetraOperator::getDomainMap() const", SWIG_UnknownError, "An unknown exception occurred", return SwigClassWrapper_uninitialized()); } } - fresult.ptr = (new Teuchos::RCP >(static_cast< const Teuchos::RCP >& >(result))); + fresult.cptr = (new Teuchos::RCP >(static_cast< const Teuchos::RCP >& >(result))); fresult.mem = SWIG_MOVE; return fresult; } @@ -6196,8 +6244,8 @@ SWIGEXPORT SwigClassWrapper _wrap_ForTpetraOperator_getRangeMap(SwigClassWrapper Teuchos::RCP< ForTpetraOperator const > *smartarg1 ; Teuchos::RCP< ForTpetraOperator::map_type const > result; - smartarg1 = static_cast< Teuchos::RCP* >(farg1->ptr); - arg1 = smartarg1 ? const_cast(smartarg1->get()) : NULL; + smartarg1 = static_cast< Teuchos::RCP* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< ForTpetraOperator* >(smartarg1->get()) : NULL; { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("ForTpetraOperator::getRangeMap() const");; @@ -6221,7 +6269,7 @@ SWIGEXPORT SwigClassWrapper _wrap_ForTpetraOperator_getRangeMap(SwigClassWrapper SWIG_exception_impl("ForTpetraOperator::getRangeMap() const", SWIG_UnknownError, "An unknown exception occurred", return SwigClassWrapper_uninitialized()); } } - fresult.ptr = (new Teuchos::RCP >(static_cast< const Teuchos::RCP >& >(result))); + fresult.cptr = (new Teuchos::RCP >(static_cast< const Teuchos::RCP >& >(result))); fresult.mem = SWIG_MOVE; return fresult; } @@ -6238,17 +6286,17 @@ SWIGEXPORT void _wrap_ForTpetraOperator_apply(SwigClassWrapper const *farg1, Swi Teuchos::RCP< Tpetra::MultiVector< SC,LO,GO,NO > const > *smartarg2 ; Teuchos::RCP< Tpetra::MultiVector< SC,LO,GO,NO > > *smartarg3 ; - smartarg1 = static_cast< Teuchos::RCP* >(farg1->ptr); - arg1 = smartarg1 ? const_cast(smartarg1->get()) : NULL; + smartarg1 = static_cast< Teuchos::RCP* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< ForTpetraOperator* >(smartarg1->get()) : NULL; SWIG_check_sp_nonnull(farg2, "ForTpetraOperator::vector_type *", "TpetraMultiVector", "ForTpetraOperator::apply(ForTpetraOperator::vector_type const &,ForTpetraOperator::vector_type &,Teuchos::ETransp,SC,SC) const", return ) - smartarg2 = static_cast< Teuchos::RCP >* >(farg2->ptr); - arg2 = const_cast*>(smartarg2->get()); + smartarg2 = static_cast< Teuchos::RCP >* >(farg2->cptr); + arg2 = const_cast< Tpetra::MultiVector* >(smartarg2->get()); SWIG_check_sp_nonnull(farg3, "ForTpetraOperator::vector_type *", "TpetraMultiVector", "ForTpetraOperator::apply(ForTpetraOperator::vector_type const &,ForTpetraOperator::vector_type &,Teuchos::ETransp,SC,SC) const", return ) - smartarg3 = static_cast< Teuchos::RCP< Tpetra::MultiVector >* >(farg3->ptr); - arg3 = smartarg3->get(); + smartarg3 = static_cast< Teuchos::RCP< Tpetra::MultiVector >* >(farg3->cptr); + arg3 = const_cast< Tpetra::MultiVector* >(smartarg3->get()); arg4 = static_cast< Teuchos::ETransp >(*farg4); - arg5 = *farg5; - arg6 = *farg6; + arg5 = static_cast< SC >(*farg5); + arg6 = static_cast< SC >(*farg6); { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("ForTpetraOperator::apply(ForTpetraOperator::vector_type const &,ForTpetraOperator::vector_type &,Teuchos::ETransp,SC,SC) const");; @@ -6280,8 +6328,8 @@ SWIGEXPORT void _wrap_delete_ForTpetraOperator(SwigClassWrapper const *farg1) { ForTpetraOperator *arg1 = (ForTpetraOperator *) 0 ; Teuchos::RCP< ForTpetraOperator > *smartarg1 ; - smartarg1 = static_cast< Teuchos::RCP< ForTpetraOperator >* >(farg1->ptr); - arg1 = smartarg1 ? smartarg1->get() : NULL; + smartarg1 = static_cast< Teuchos::RCP< ForTpetraOperator >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< ForTpetraOperator* >(smartarg1->get()) : NULL; { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("ForTpetraOperator::~ForTpetraOperator()");; @@ -6310,7 +6358,7 @@ SWIGEXPORT void _wrap_delete_ForTpetraOperator(SwigClassWrapper const *farg1) { SWIGEXPORT void _wrap_assign_ForTpetraOperator(SwigClassWrapper * self, SwigClassWrapper const * other) { - typedef ::Teuchos::RCP< ForTpetraOperator > swig_lhs_classtype; + typedef Teuchos::RCP< ForTpetraOperator > swig_lhs_classtype; SWIG_assign(swig_lhs_classtype, self, swig_lhs_classtype, const_cast(other), 0 | swig::IS_DESTR | swig::IS_COPY_CONSTR); @@ -6322,8 +6370,8 @@ SWIGEXPORT void _wrap_RowInfo_localRow_set(SwigClassWrapper const *farg1, size_t size_t arg2 ; SWIG_check_mutable_nonnull(*farg1, "Tpetra::RowInfo *", "RowInfo", "Tpetra::RowInfo::localRow", return ); - arg1 = static_cast< Tpetra::RowInfo * >(farg1->ptr); - arg2 = *farg2; + arg1 = static_cast< Tpetra::RowInfo * >(farg1->cptr); + arg2 = static_cast< size_t >(*farg2); if (arg1) (arg1)->localRow = arg2; } @@ -6335,9 +6383,9 @@ SWIGEXPORT size_t _wrap_RowInfo_localRow_get(SwigClassWrapper const *farg1) { size_t result; SWIG_check_mutable_nonnull(*farg1, "Tpetra::RowInfo *", "RowInfo", "Tpetra::RowInfo::localRow", return 0); - arg1 = static_cast< Tpetra::RowInfo * >(farg1->ptr); + arg1 = static_cast< Tpetra::RowInfo * >(farg1->cptr); result = (size_t) ((arg1)->localRow); - fresult = result; + fresult = static_cast< size_t >(result); return fresult; } @@ -6347,8 +6395,8 @@ SWIGEXPORT void _wrap_RowInfo_allocSize_set(SwigClassWrapper const *farg1, size_ size_t arg2 ; SWIG_check_mutable_nonnull(*farg1, "Tpetra::RowInfo *", "RowInfo", "Tpetra::RowInfo::allocSize", return ); - arg1 = static_cast< Tpetra::RowInfo * >(farg1->ptr); - arg2 = *farg2; + arg1 = static_cast< Tpetra::RowInfo * >(farg1->cptr); + arg2 = static_cast< size_t >(*farg2); if (arg1) (arg1)->allocSize = arg2; } @@ -6360,9 +6408,9 @@ SWIGEXPORT size_t _wrap_RowInfo_allocSize_get(SwigClassWrapper const *farg1) { size_t result; SWIG_check_mutable_nonnull(*farg1, "Tpetra::RowInfo *", "RowInfo", "Tpetra::RowInfo::allocSize", return 0); - arg1 = static_cast< Tpetra::RowInfo * >(farg1->ptr); + arg1 = static_cast< Tpetra::RowInfo * >(farg1->cptr); result = (size_t) ((arg1)->allocSize); - fresult = result; + fresult = static_cast< size_t >(result); return fresult; } @@ -6372,8 +6420,8 @@ SWIGEXPORT void _wrap_RowInfo_numEntries_set(SwigClassWrapper const *farg1, size size_t arg2 ; SWIG_check_mutable_nonnull(*farg1, "Tpetra::RowInfo *", "RowInfo", "Tpetra::RowInfo::numEntries", return ); - arg1 = static_cast< Tpetra::RowInfo * >(farg1->ptr); - arg2 = *farg2; + arg1 = static_cast< Tpetra::RowInfo * >(farg1->cptr); + arg2 = static_cast< size_t >(*farg2); if (arg1) (arg1)->numEntries = arg2; } @@ -6385,9 +6433,9 @@ SWIGEXPORT size_t _wrap_RowInfo_numEntries_get(SwigClassWrapper const *farg1) { size_t result; SWIG_check_mutable_nonnull(*farg1, "Tpetra::RowInfo *", "RowInfo", "Tpetra::RowInfo::numEntries", return 0); - arg1 = static_cast< Tpetra::RowInfo * >(farg1->ptr); + arg1 = static_cast< Tpetra::RowInfo * >(farg1->cptr); result = (size_t) ((arg1)->numEntries); - fresult = result; + fresult = static_cast< size_t >(result); return fresult; } @@ -6397,8 +6445,8 @@ SWIGEXPORT void _wrap_RowInfo_offset1D_set(SwigClassWrapper const *farg1, size_t size_t arg2 ; SWIG_check_mutable_nonnull(*farg1, "Tpetra::RowInfo *", "RowInfo", "Tpetra::RowInfo::offset1D", return ); - arg1 = static_cast< Tpetra::RowInfo * >(farg1->ptr); - arg2 = *farg2; + arg1 = static_cast< Tpetra::RowInfo * >(farg1->cptr); + arg2 = static_cast< size_t >(*farg2); if (arg1) (arg1)->offset1D = arg2; } @@ -6410,9 +6458,9 @@ SWIGEXPORT size_t _wrap_RowInfo_offset1D_get(SwigClassWrapper const *farg1) { size_t result; SWIG_check_mutable_nonnull(*farg1, "Tpetra::RowInfo *", "RowInfo", "Tpetra::RowInfo::offset1D", return 0); - arg1 = static_cast< Tpetra::RowInfo * >(farg1->ptr); + arg1 = static_cast< Tpetra::RowInfo * >(farg1->cptr); result = (size_t) ((arg1)->offset1D); - fresult = result; + fresult = static_cast< size_t >(result); return fresult; } @@ -6444,7 +6492,7 @@ SWIGEXPORT SwigClassWrapper _wrap_new_RowInfo() { SWIG_exception_impl("Tpetra::RowInfo::RowInfo()", SWIG_UnknownError, "An unknown exception occurred", return SwigClassWrapper_uninitialized()); } } - fresult.ptr = result; + fresult.cptr = result; fresult.mem = (1 ? SWIG_MOVE : SWIG_REF); return fresult; } @@ -6454,7 +6502,7 @@ SWIGEXPORT void _wrap_delete_RowInfo(SwigClassWrapper const *farg1) { Tpetra::RowInfo *arg1 = (Tpetra::RowInfo *) 0 ; SWIG_check_mutable_nonnull(*farg1, "Tpetra::RowInfo *", "RowInfo", "Tpetra::RowInfo::~RowInfo()", return ); - arg1 = static_cast< Tpetra::RowInfo * >(farg1->ptr); + arg1 = static_cast< Tpetra::RowInfo * >(farg1->cptr); { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::RowInfo::~RowInfo()");; @@ -6483,7 +6531,7 @@ SWIGEXPORT void _wrap_delete_RowInfo(SwigClassWrapper const *farg1) { SWIGEXPORT void _wrap_assign_RowInfo(SwigClassWrapper * self, SwigClassWrapper const * other) { - typedef ::Tpetra::RowInfo swig_lhs_classtype; + typedef Tpetra::RowInfo swig_lhs_classtype; SWIG_assign(swig_lhs_classtype, self, swig_lhs_classtype, const_cast(other), 0 | swig::IS_DESTR | swig::IS_COPY_CONSTR); @@ -6500,10 +6548,10 @@ SWIGEXPORT SwigClassWrapper _wrap_new_TpetraCrsGraph__SWIG_0(SwigClassWrapper co Teuchos::RCP< Teuchos::ParameterList > tempnull4 ; Tpetra::CrsGraph< LO,GO,NO > *result = 0 ; - arg1 = farg1->ptr ? static_cast< Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg1->ptr) : &tempnull1; - arg2 = *farg2; + arg1 = farg1->cptr ? static_cast< Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg1->cptr) : &tempnull1; + arg2 = static_cast< size_t >(*farg2); arg3 = static_cast< Tpetra::ProfileType >(*farg3); - arg4 = farg4->ptr ? static_cast< Teuchos::RCP< Teuchos::ParameterList > * >(farg4->ptr) : &tempnull4; + arg4 = farg4->cptr ? static_cast< Teuchos::RCP< Teuchos::ParameterList > * >(farg4->cptr) : &tempnull4; { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::CrsGraph(Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,size_t const,Tpetra::ProfileType const,Teuchos::RCP< Teuchos::ParameterList > const &)");; @@ -6527,7 +6575,7 @@ SWIGEXPORT SwigClassWrapper _wrap_new_TpetraCrsGraph__SWIG_0(SwigClassWrapper co SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::CrsGraph(Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,size_t const,Tpetra::ProfileType const,Teuchos::RCP< Teuchos::ParameterList > const &)", SWIG_UnknownError, "An unknown exception occurred", return SwigClassWrapper_uninitialized()); } } - fresult.ptr = result ? new Teuchos::RCP< Tpetra::CrsGraph >(result SWIG_NO_NULL_DELETER_1) : NULL; + fresult.cptr = result ? new Teuchos::RCP< Tpetra::CrsGraph >(result SWIG_NO_NULL_DELETER_1) : NULL; fresult.mem = SWIG_MOVE; return fresult; } @@ -6541,8 +6589,8 @@ SWIGEXPORT SwigClassWrapper _wrap_new_TpetraCrsGraph__SWIG_1(SwigClassWrapper co Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > tempnull1 ; Tpetra::CrsGraph< LO,GO,NO > *result = 0 ; - arg1 = farg1->ptr ? static_cast< Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg1->ptr) : &tempnull1; - arg2 = *farg2; + arg1 = farg1->cptr ? static_cast< Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg1->cptr) : &tempnull1; + arg2 = static_cast< size_t >(*farg2); arg3 = static_cast< Tpetra::ProfileType >(*farg3); { // Make sure no unhandled exceptions exist before performing a new action @@ -6567,7 +6615,7 @@ SWIGEXPORT SwigClassWrapper _wrap_new_TpetraCrsGraph__SWIG_1(SwigClassWrapper co SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::CrsGraph(Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,size_t const,Tpetra::ProfileType const)", SWIG_UnknownError, "An unknown exception occurred", return SwigClassWrapper_uninitialized()); } } - fresult.ptr = result ? new Teuchos::RCP< Tpetra::CrsGraph >(result SWIG_NO_NULL_DELETER_1) : NULL; + fresult.cptr = result ? new Teuchos::RCP< Tpetra::CrsGraph >(result SWIG_NO_NULL_DELETER_1) : NULL; fresult.mem = SWIG_MOVE; return fresult; } @@ -6579,9 +6627,9 @@ SWIGEXPORT SwigClassWrapper _wrap_new_TpetraCrsGraph__SWIG_2(SwigClassWrapper co size_t arg2 ; Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > tempnull1 ; Tpetra::CrsGraph< LO,GO,NO > *result = 0 ; - - arg1 = farg1->ptr ? static_cast< Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg1->ptr) : &tempnull1; - arg2 = *farg2; + + arg1 = farg1->cptr ? static_cast< Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg1->cptr) : &tempnull1; + arg2 = static_cast< size_t >(*farg2); { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::CrsGraph(Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,size_t const)");; @@ -6605,7 +6653,7 @@ SWIGEXPORT SwigClassWrapper _wrap_new_TpetraCrsGraph__SWIG_2(SwigClassWrapper co SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::CrsGraph(Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,size_t const)", SWIG_UnknownError, "An unknown exception occurred", return SwigClassWrapper_uninitialized()); } } - fresult.ptr = result ? new Teuchos::RCP< Tpetra::CrsGraph >(result SWIG_NO_NULL_DELETER_1) : NULL; + fresult.cptr = result ? new Teuchos::RCP< Tpetra::CrsGraph >(result SWIG_NO_NULL_DELETER_1) : NULL; fresult.mem = SWIG_MOVE; return fresult; } @@ -6622,12 +6670,12 @@ SWIGEXPORT SwigClassWrapper _wrap_new_TpetraCrsGraph__SWIG_3(SwigClassWrapper co Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > tempnull2 ; Teuchos::RCP< Teuchos::ParameterList > tempnull5 ; Tpetra::CrsGraph< LO,GO,NO > *result = 0 ; - - arg1 = farg1->ptr ? static_cast< Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg1->ptr) : &tempnull1; - arg2 = farg2->ptr ? static_cast< Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg2->ptr) : &tempnull2; - arg3 = *farg3; + + arg1 = farg1->cptr ? static_cast< Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg1->cptr) : &tempnull1; + arg2 = farg2->cptr ? static_cast< Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg2->cptr) : &tempnull2; + arg3 = static_cast< size_t >(*farg3); arg4 = static_cast< Tpetra::ProfileType >(*farg4); - arg5 = farg5->ptr ? static_cast< Teuchos::RCP< Teuchos::ParameterList > * >(farg5->ptr) : &tempnull5; + arg5 = farg5->cptr ? static_cast< Teuchos::RCP< Teuchos::ParameterList > * >(farg5->cptr) : &tempnull5; { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::CrsGraph(Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,size_t const,Tpetra::ProfileType const,Teuchos::RCP< Teuchos::ParameterList > const &)");; @@ -6651,7 +6699,7 @@ SWIGEXPORT SwigClassWrapper _wrap_new_TpetraCrsGraph__SWIG_3(SwigClassWrapper co SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::CrsGraph(Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,size_t const,Tpetra::ProfileType const,Teuchos::RCP< Teuchos::ParameterList > const &)", SWIG_UnknownError, "An unknown exception occurred", return SwigClassWrapper_uninitialized()); } } - fresult.ptr = result ? new Teuchos::RCP< Tpetra::CrsGraph >(result SWIG_NO_NULL_DELETER_1) : NULL; + fresult.cptr = result ? new Teuchos::RCP< Tpetra::CrsGraph >(result SWIG_NO_NULL_DELETER_1) : NULL; fresult.mem = SWIG_MOVE; return fresult; } @@ -6666,10 +6714,10 @@ SWIGEXPORT SwigClassWrapper _wrap_new_TpetraCrsGraph__SWIG_4(SwigClassWrapper co Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > tempnull1 ; Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > tempnull2 ; Tpetra::CrsGraph< LO,GO,NO > *result = 0 ; - - arg1 = farg1->ptr ? static_cast< Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg1->ptr) : &tempnull1; - arg2 = farg2->ptr ? static_cast< Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg2->ptr) : &tempnull2; - arg3 = *farg3; + + arg1 = farg1->cptr ? static_cast< Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg1->cptr) : &tempnull1; + arg2 = farg2->cptr ? static_cast< Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg2->cptr) : &tempnull2; + arg3 = static_cast< size_t >(*farg3); arg4 = static_cast< Tpetra::ProfileType >(*farg4); { // Make sure no unhandled exceptions exist before performing a new action @@ -6694,7 +6742,7 @@ SWIGEXPORT SwigClassWrapper _wrap_new_TpetraCrsGraph__SWIG_4(SwigClassWrapper co SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::CrsGraph(Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,size_t const,Tpetra::ProfileType const)", SWIG_UnknownError, "An unknown exception occurred", return SwigClassWrapper_uninitialized()); } } - fresult.ptr = result ? new Teuchos::RCP< Tpetra::CrsGraph >(result SWIG_NO_NULL_DELETER_1) : NULL; + fresult.cptr = result ? new Teuchos::RCP< Tpetra::CrsGraph >(result SWIG_NO_NULL_DELETER_1) : NULL; fresult.mem = SWIG_MOVE; return fresult; } @@ -6708,10 +6756,10 @@ SWIGEXPORT SwigClassWrapper _wrap_new_TpetraCrsGraph__SWIG_5(SwigClassWrapper co Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > tempnull1 ; Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > tempnull2 ; Tpetra::CrsGraph< LO,GO,NO > *result = 0 ; - - arg1 = farg1->ptr ? static_cast< Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg1->ptr) : &tempnull1; - arg2 = farg2->ptr ? static_cast< Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg2->ptr) : &tempnull2; - arg3 = *farg3; + + arg1 = farg1->cptr ? static_cast< Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg1->cptr) : &tempnull1; + arg2 = farg2->cptr ? static_cast< Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg2->cptr) : &tempnull2; + arg3 = static_cast< size_t >(*farg3); { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::CrsGraph(Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,size_t const)");; @@ -6735,7 +6783,7 @@ SWIGEXPORT SwigClassWrapper _wrap_new_TpetraCrsGraph__SWIG_5(SwigClassWrapper co SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::CrsGraph(Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,size_t const)", SWIG_UnknownError, "An unknown exception occurred", return SwigClassWrapper_uninitialized()); } } - fresult.ptr = result ? new Teuchos::RCP< Tpetra::CrsGraph >(result SWIG_NO_NULL_DELETER_1) : NULL; + fresult.cptr = result ? new Teuchos::RCP< Tpetra::CrsGraph >(result SWIG_NO_NULL_DELETER_1) : NULL; fresult.mem = SWIG_MOVE; return fresult; } @@ -6744,16 +6792,16 @@ SWIGEXPORT SwigClassWrapper _wrap_new_TpetraCrsGraph__SWIG_5(SwigClassWrapper co SWIGEXPORT void _wrap_delete_TpetraCrsGraph(SwigClassWrapper const *farg1) { Tpetra::CrsGraph< LO,GO,NO > *arg1 = (Tpetra::CrsGraph< LO,GO,NO > *) 0 ; Teuchos::RCP< Tpetra::CrsGraph< LO,GO,NO > > *smartarg1 ; - - smartarg1 = static_cast< Teuchos::RCP< Tpetra::CrsGraph >* >(farg1->ptr); - arg1 = smartarg1 ? smartarg1->get() : NULL; + + smartarg1 = static_cast< Teuchos::RCP< Tpetra::CrsGraph >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::CrsGraph* >(smartarg1->get()) : NULL; { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::~CrsGraph()");; try { // Attempt the wrapped function call - (void)arg1; delete smartarg1; + (void)arg1; delete smartarg1; } catch (const std::range_error& e) { @@ -6770,7 +6818,7 @@ SWIGEXPORT void _wrap_delete_TpetraCrsGraph(SwigClassWrapper const *farg1) { SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::~CrsGraph()", SWIG_UnknownError, "An unknown exception occurred", return ); } } - + } @@ -6779,12 +6827,12 @@ SWIGEXPORT void _wrap_TpetraCrsGraph_swap(SwigClassWrapper const *farg1, SwigCla Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode > *arg2 = 0 ; Teuchos::RCP< Tpetra::CrsGraph< LO,GO,NO > > *smartarg1 ; Teuchos::RCP< Tpetra::CrsGraph< LO,GO,NO > > *smartarg2 ; - - smartarg1 = static_cast< Teuchos::RCP< Tpetra::CrsGraph >* >(farg1->ptr); - arg1 = smartarg1 ? smartarg1->get() : NULL; + + smartarg1 = static_cast< Teuchos::RCP< Tpetra::CrsGraph >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::CrsGraph* >(smartarg1->get()) : NULL; SWIG_check_sp_nonnull(farg2, "Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode > *", "TpetraCrsGraph", "Tpetra::CrsGraph< LO,GO,NO >::swap(Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode > &)", return ) - smartarg2 = static_cast< Teuchos::RCP< Tpetra::CrsGraph >* >(farg2->ptr); - arg2 = smartarg2->get(); + smartarg2 = static_cast< Teuchos::RCP< Tpetra::CrsGraph >* >(farg2->cptr); + arg2 = const_cast< Tpetra::CrsGraph* >(smartarg2->get()); { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::swap(Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode > &)");; @@ -6808,7 +6856,7 @@ SWIGEXPORT void _wrap_TpetraCrsGraph_swap(SwigClassWrapper const *farg1, SwigCla SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::swap(Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode > &)", SWIG_UnknownError, "An unknown exception occurred", return ); } } - + } @@ -6819,12 +6867,12 @@ SWIGEXPORT bool _wrap_TpetraCrsGraph_isIdenticalTo(SwigClassWrapper const *farg1 Teuchos::RCP< Tpetra::CrsGraph< LO,GO,NO > const > *smartarg1 ; Teuchos::RCP< Tpetra::CrsGraph< LO,GO,NO > const > *smartarg2 ; bool result; - - smartarg1 = static_cast< Teuchos::RCP >* >(farg1->ptr); - arg1 = smartarg1 ? const_cast*>(smartarg1->get()) : NULL; + + smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::CrsGraph* >(smartarg1->get()) : NULL; SWIG_check_sp_nonnull(farg2, "Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode > *", "TpetraCrsGraph", "Tpetra::CrsGraph< LO,GO,NO >::isIdenticalTo(Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &) const", return 0) - smartarg2 = static_cast< Teuchos::RCP >* >(farg2->ptr); - arg2 = const_cast*>(smartarg2->get()); + smartarg2 = static_cast< Teuchos::RCP >* >(farg2->cptr); + arg2 = const_cast< Tpetra::CrsGraph* >(smartarg2->get()); { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::isIdenticalTo(Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &) const");; @@ -6848,7 +6896,7 @@ SWIGEXPORT bool _wrap_TpetraCrsGraph_isIdenticalTo(SwigClassWrapper const *farg1 SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::isIdenticalTo(Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &) const", SWIG_UnknownError, "An unknown exception occurred", return 0); } } - fresult = result; + fresult = static_cast< bool >(result); return fresult; } @@ -6858,10 +6906,10 @@ SWIGEXPORT void _wrap_TpetraCrsGraph_setParameterList(SwigClassWrapper const *fa Teuchos::RCP< Teuchos::ParameterList > *arg2 = 0 ; Teuchos::RCP< Tpetra::CrsGraph< LO,GO,NO > > *smartarg1 ; Teuchos::RCP< Teuchos::ParameterList > tempnull2 ; - - smartarg1 = static_cast< Teuchos::RCP< Tpetra::CrsGraph >* >(farg1->ptr); - arg1 = smartarg1 ? smartarg1->get() : NULL; - arg2 = farg2->ptr ? static_cast< Teuchos::RCP< Teuchos::ParameterList > * >(farg2->ptr) : &tempnull2; + + smartarg1 = static_cast< Teuchos::RCP< Tpetra::CrsGraph >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::CrsGraph* >(smartarg1->get()) : NULL; + arg2 = farg2->cptr ? static_cast< Teuchos::RCP< Teuchos::ParameterList > * >(farg2->cptr) : &tempnull2; { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::setParameterList(Teuchos::RCP< Teuchos::ParameterList > const &)");; @@ -6885,7 +6933,7 @@ SWIGEXPORT void _wrap_TpetraCrsGraph_setParameterList(SwigClassWrapper const *fa SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::setParameterList(Teuchos::RCP< Teuchos::ParameterList > const &)", SWIG_UnknownError, "An unknown exception occurred", return ); } } - + } @@ -6894,9 +6942,9 @@ SWIGEXPORT SwigClassWrapper _wrap_TpetraCrsGraph_getValidParameters(SwigClassWra Tpetra::CrsGraph< LO,GO,NO > *arg1 = (Tpetra::CrsGraph< LO,GO,NO > *) 0 ; Teuchos::RCP< Tpetra::CrsGraph< LO,GO,NO > const > *smartarg1 ; Teuchos::RCP< Teuchos::ParameterList const > result; - - smartarg1 = static_cast< Teuchos::RCP >* >(farg1->ptr); - arg1 = smartarg1 ? const_cast*>(smartarg1->get()) : NULL; + + smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::CrsGraph* >(smartarg1->get()) : NULL; { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::getValidParameters() const");; @@ -6920,24 +6968,24 @@ SWIGEXPORT SwigClassWrapper _wrap_TpetraCrsGraph_getValidParameters(SwigClassWra SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::getValidParameters() const", SWIG_UnknownError, "An unknown exception occurred", return SwigClassWrapper_uninitialized()); } } - fresult.ptr = (new Teuchos::RCP(static_cast< const Teuchos::RCP& >(result))); + fresult.cptr = (new Teuchos::RCP(static_cast< const Teuchos::RCP& >(result))); fresult.mem = SWIG_MOVE; return fresult; } -SWIGEXPORT void _wrap_TpetraCrsGraph_insertGlobalIndices__SWIG_0(SwigClassWrapper const *farg1, long long const *farg2, int const *farg3, long long *farg4) { +SWIGEXPORT void _wrap_TpetraCrsGraph_insertGlobalIndices__SWIG_0(SwigClassWrapper const *farg1, long long const *farg2, int const *farg3, long long const *farg4) { Tpetra::CrsGraph< LO,GO,NO > *arg1 = (Tpetra::CrsGraph< LO,GO,NO > *) 0 ; long long arg2 ; int arg3 ; long long *arg4 ; Teuchos::RCP< Tpetra::CrsGraph< LO,GO,NO > > *smartarg1 ; - - smartarg1 = static_cast< Teuchos::RCP< Tpetra::CrsGraph >* >(farg1->ptr); - arg1 = smartarg1 ? smartarg1->get() : NULL; - arg2 = *farg2; - arg3 = *farg3; - arg4 = reinterpret_cast< long long * >(farg4); + + smartarg1 = static_cast< Teuchos::RCP< Tpetra::CrsGraph >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::CrsGraph* >(smartarg1->get()) : NULL; + arg2 = static_cast< long long >(*farg2); + arg3 = static_cast< int >(*farg3); + arg4 = const_cast< long long * >(farg4); { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::insertGlobalIndices(long long const,int const,long long const [])");; @@ -6961,7 +7009,7 @@ SWIGEXPORT void _wrap_TpetraCrsGraph_insertGlobalIndices__SWIG_0(SwigClassWrappe SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::insertGlobalIndices(long long const,int const,long long const [])", SWIG_UnknownError, "An unknown exception occurred", return ); } } - + } @@ -6969,9 +7017,9 @@ SWIGEXPORT void _wrap_TpetraCrsGraph_removeLocalIndices(SwigClassWrapper const * Tpetra::CrsGraph< LO,GO,NO > *arg1 = (Tpetra::CrsGraph< LO,GO,NO > *) 0 ; int arg2 ; Teuchos::RCP< Tpetra::CrsGraph< LO,GO,NO > > *smartarg1 ; - - smartarg1 = static_cast< Teuchos::RCP< Tpetra::CrsGraph >* >(farg1->ptr); - arg1 = smartarg1 ? smartarg1->get() : NULL; + + smartarg1 = static_cast< Teuchos::RCP< Tpetra::CrsGraph >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::CrsGraph* >(smartarg1->get()) : NULL; arg2 = *farg2 - 1; { // Make sure no unhandled exceptions exist before performing a new action @@ -6996,16 +7044,16 @@ SWIGEXPORT void _wrap_TpetraCrsGraph_removeLocalIndices(SwigClassWrapper const * SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::removeLocalIndices(int)", SWIG_UnknownError, "An unknown exception occurred", return ); } } - + } SWIGEXPORT void _wrap_TpetraCrsGraph_globalAssemble(SwigClassWrapper const *farg1) { Tpetra::CrsGraph< LO,GO,NO > *arg1 = (Tpetra::CrsGraph< LO,GO,NO > *) 0 ; Teuchos::RCP< Tpetra::CrsGraph< LO,GO,NO > > *smartarg1 ; - - smartarg1 = static_cast< Teuchos::RCP< Tpetra::CrsGraph >* >(farg1->ptr); - arg1 = smartarg1 ? smartarg1->get() : NULL; + + smartarg1 = static_cast< Teuchos::RCP< Tpetra::CrsGraph >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::CrsGraph* >(smartarg1->get()) : NULL; { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::globalAssemble()");; @@ -7029,7 +7077,7 @@ SWIGEXPORT void _wrap_TpetraCrsGraph_globalAssemble(SwigClassWrapper const *farg SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::globalAssemble()", SWIG_UnknownError, "An unknown exception occurred", return ); } } - + } @@ -7038,10 +7086,10 @@ SWIGEXPORT void _wrap_TpetraCrsGraph_resumeFill__SWIG_0(SwigClassWrapper const * Teuchos::RCP< Teuchos::ParameterList > *arg2 = 0 ; Teuchos::RCP< Tpetra::CrsGraph< LO,GO,NO > > *smartarg1 ; Teuchos::RCP< Teuchos::ParameterList > tempnull2 ; - - smartarg1 = static_cast< Teuchos::RCP< Tpetra::CrsGraph >* >(farg1->ptr); - arg1 = smartarg1 ? smartarg1->get() : NULL; - arg2 = farg2->ptr ? static_cast< Teuchos::RCP< Teuchos::ParameterList > * >(farg2->ptr) : &tempnull2; + + smartarg1 = static_cast< Teuchos::RCP< Tpetra::CrsGraph >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::CrsGraph* >(smartarg1->get()) : NULL; + arg2 = farg2->cptr ? static_cast< Teuchos::RCP< Teuchos::ParameterList > * >(farg2->cptr) : &tempnull2; { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::resumeFill(Teuchos::RCP< Teuchos::ParameterList > const &)");; @@ -7065,16 +7113,16 @@ SWIGEXPORT void _wrap_TpetraCrsGraph_resumeFill__SWIG_0(SwigClassWrapper const * SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::resumeFill(Teuchos::RCP< Teuchos::ParameterList > const &)", SWIG_UnknownError, "An unknown exception occurred", return ); } } - + } SWIGEXPORT void _wrap_TpetraCrsGraph_resumeFill__SWIG_1(SwigClassWrapper const *farg1) { Tpetra::CrsGraph< LO,GO,NO > *arg1 = (Tpetra::CrsGraph< LO,GO,NO > *) 0 ; Teuchos::RCP< Tpetra::CrsGraph< LO,GO,NO > > *smartarg1 ; - - smartarg1 = static_cast< Teuchos::RCP< Tpetra::CrsGraph >* >(farg1->ptr); - arg1 = smartarg1 ? smartarg1->get() : NULL; + + smartarg1 = static_cast< Teuchos::RCP< Tpetra::CrsGraph >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::CrsGraph* >(smartarg1->get()) : NULL; { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::resumeFill()");; @@ -7098,7 +7146,7 @@ SWIGEXPORT void _wrap_TpetraCrsGraph_resumeFill__SWIG_1(SwigClassWrapper const * SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::resumeFill()", SWIG_UnknownError, "An unknown exception occurred", return ); } } - + } @@ -7112,11 +7160,11 @@ SWIGEXPORT void _wrap_TpetraCrsGraph_fillComplete__SWIG_0(SwigClassWrapper const Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > tempnull3 ; Teuchos::RCP< Teuchos::ParameterList > tempnull4 ; - smartarg1 = static_cast< Teuchos::RCP< Tpetra::CrsGraph >* >(farg1->ptr); - arg1 = smartarg1 ? smartarg1->get() : NULL; - arg2 = farg2->ptr ? static_cast< Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg2->ptr) : &tempnull2; - arg3 = farg3->ptr ? static_cast< Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg3->ptr) : &tempnull3; - arg4 = farg4->ptr ? static_cast< Teuchos::RCP< Teuchos::ParameterList > * >(farg4->ptr) : &tempnull4; + smartarg1 = static_cast< Teuchos::RCP< Tpetra::CrsGraph >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::CrsGraph* >(smartarg1->get()) : NULL; + arg2 = farg2->cptr ? static_cast< Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg2->cptr) : &tempnull2; + arg3 = farg3->cptr ? static_cast< Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg3->cptr) : &tempnull3; + arg4 = farg4->cptr ? static_cast< Teuchos::RCP< Teuchos::ParameterList > * >(farg4->cptr) : &tempnull4; { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::fillComplete(Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Teuchos::ParameterList > const &)");; @@ -7140,7 +7188,7 @@ SWIGEXPORT void _wrap_TpetraCrsGraph_fillComplete__SWIG_0(SwigClassWrapper const SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::fillComplete(Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Teuchos::ParameterList > const &)", SWIG_UnknownError, "An unknown exception occurred", return ); } } - + } @@ -7152,10 +7200,10 @@ SWIGEXPORT void _wrap_TpetraCrsGraph_fillComplete__SWIG_1(SwigClassWrapper const Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > tempnull2 ; Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > tempnull3 ; - smartarg1 = static_cast< Teuchos::RCP< Tpetra::CrsGraph >* >(farg1->ptr); - arg1 = smartarg1 ? smartarg1->get() : NULL; - arg2 = farg2->ptr ? static_cast< Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg2->ptr) : &tempnull2; - arg3 = farg3->ptr ? static_cast< Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg3->ptr) : &tempnull3; + smartarg1 = static_cast< Teuchos::RCP< Tpetra::CrsGraph >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::CrsGraph* >(smartarg1->get()) : NULL; + arg2 = farg2->cptr ? static_cast< Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg2->cptr) : &tempnull2; + arg3 = farg3->cptr ? static_cast< Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg3->cptr) : &tempnull3; { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::fillComplete(Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &)");; @@ -7179,7 +7227,7 @@ SWIGEXPORT void _wrap_TpetraCrsGraph_fillComplete__SWIG_1(SwigClassWrapper const SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::fillComplete(Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &)", SWIG_UnknownError, "An unknown exception occurred", return ); } } - + } @@ -7189,9 +7237,9 @@ SWIGEXPORT void _wrap_TpetraCrsGraph_fillComplete__SWIG_2(SwigClassWrapper const Teuchos::RCP< Tpetra::CrsGraph< LO,GO,NO > > *smartarg1 ; Teuchos::RCP< Teuchos::ParameterList > tempnull2 ; - smartarg1 = static_cast< Teuchos::RCP< Tpetra::CrsGraph >* >(farg1->ptr); - arg1 = smartarg1 ? smartarg1->get() : NULL; - arg2 = farg2->ptr ? static_cast< Teuchos::RCP< Teuchos::ParameterList > * >(farg2->ptr) : &tempnull2; + smartarg1 = static_cast< Teuchos::RCP< Tpetra::CrsGraph >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::CrsGraph* >(smartarg1->get()) : NULL; + arg2 = farg2->cptr ? static_cast< Teuchos::RCP< Teuchos::ParameterList > * >(farg2->cptr) : &tempnull2; { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::fillComplete(Teuchos::RCP< Teuchos::ParameterList > const &)");; @@ -7215,7 +7263,7 @@ SWIGEXPORT void _wrap_TpetraCrsGraph_fillComplete__SWIG_2(SwigClassWrapper const SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::fillComplete(Teuchos::RCP< Teuchos::ParameterList > const &)", SWIG_UnknownError, "An unknown exception occurred", return ); } } - + } @@ -7223,8 +7271,8 @@ SWIGEXPORT void _wrap_TpetraCrsGraph_fillComplete__SWIG_3(SwigClassWrapper const Tpetra::CrsGraph< LO,GO,NO > *arg1 = (Tpetra::CrsGraph< LO,GO,NO > *) 0 ; Teuchos::RCP< Tpetra::CrsGraph< LO,GO,NO > > *smartarg1 ; - smartarg1 = static_cast< Teuchos::RCP< Tpetra::CrsGraph >* >(farg1->ptr); - arg1 = smartarg1 ? smartarg1->get() : NULL; + smartarg1 = static_cast< Teuchos::RCP< Tpetra::CrsGraph >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::CrsGraph* >(smartarg1->get()) : NULL; { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::fillComplete()");; @@ -7248,7 +7296,7 @@ SWIGEXPORT void _wrap_TpetraCrsGraph_fillComplete__SWIG_3(SwigClassWrapper const SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::fillComplete()", SWIG_UnknownError, "An unknown exception occurred", return ); } } - + } @@ -7266,13 +7314,13 @@ SWIGEXPORT void _wrap_TpetraCrsGraph_expertStaticFillComplete__SWIG_0(SwigClassW Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::export_type const > tempnull5 ; Teuchos::RCP< Teuchos::ParameterList > tempnull6 ; - smartarg1 = static_cast< Teuchos::RCP< Tpetra::CrsGraph >* >(farg1->ptr); - arg1 = smartarg1 ? smartarg1->get() : NULL; - arg2 = farg2->ptr ? static_cast< Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg2->ptr) : &tempnull2; - arg3 = farg3->ptr ? static_cast< Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg3->ptr) : &tempnull3; - arg4 = farg4->ptr ? static_cast< Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::import_type const > * >(farg4->ptr) : &tempnull4; - arg5 = farg5->ptr ? static_cast< Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::export_type const > * >(farg5->ptr) : &tempnull5; - arg6 = farg6->ptr ? static_cast< Teuchos::RCP< Teuchos::ParameterList > * >(farg6->ptr) : &tempnull6; + smartarg1 = static_cast< Teuchos::RCP< Tpetra::CrsGraph >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::CrsGraph* >(smartarg1->get()) : NULL; + arg2 = farg2->cptr ? static_cast< Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg2->cptr) : &tempnull2; + arg3 = farg3->cptr ? static_cast< Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg3->cptr) : &tempnull3; + arg4 = farg4->cptr ? static_cast< Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::import_type const > * >(farg4->cptr) : &tempnull4; + arg5 = farg5->cptr ? static_cast< Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::export_type const > * >(farg5->cptr) : &tempnull5; + arg6 = farg6->cptr ? static_cast< Teuchos::RCP< Teuchos::ParameterList > * >(farg6->cptr) : &tempnull6; { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::expertStaticFillComplete(Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::import_type const > const &,Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::export_type const > const &,Teuchos::RCP< Teuchos::ParameterList > const &)");; @@ -7312,12 +7360,12 @@ SWIGEXPORT void _wrap_TpetraCrsGraph_expertStaticFillComplete__SWIG_1(SwigClassW Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::import_type const > tempnull4 ; Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::export_type const > tempnull5 ; - smartarg1 = static_cast< Teuchos::RCP< Tpetra::CrsGraph >* >(farg1->ptr); - arg1 = smartarg1 ? smartarg1->get() : NULL; - arg2 = farg2->ptr ? static_cast< Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg2->ptr) : &tempnull2; - arg3 = farg3->ptr ? static_cast< Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg3->ptr) : &tempnull3; - arg4 = farg4->ptr ? static_cast< Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::import_type const > * >(farg4->ptr) : &tempnull4; - arg5 = farg5->ptr ? static_cast< Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::export_type const > * >(farg5->ptr) : &tempnull5; + smartarg1 = static_cast< Teuchos::RCP< Tpetra::CrsGraph >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::CrsGraph* >(smartarg1->get()) : NULL; + arg2 = farg2->cptr ? static_cast< Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg2->cptr) : &tempnull2; + arg3 = farg3->cptr ? static_cast< Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg3->cptr) : &tempnull3; + arg4 = farg4->cptr ? static_cast< Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::import_type const > * >(farg4->cptr) : &tempnull4; + arg5 = farg5->cptr ? static_cast< Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::export_type const > * >(farg5->cptr) : &tempnull5; { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::expertStaticFillComplete(Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::import_type const > const &,Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::export_type const > const &)");; @@ -7355,11 +7403,11 @@ SWIGEXPORT void _wrap_TpetraCrsGraph_expertStaticFillComplete__SWIG_2(SwigClassW Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > tempnull3 ; Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::import_type const > tempnull4 ; - smartarg1 = static_cast< Teuchos::RCP< Tpetra::CrsGraph >* >(farg1->ptr); - arg1 = smartarg1 ? smartarg1->get() : NULL; - arg2 = farg2->ptr ? static_cast< Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg2->ptr) : &tempnull2; - arg3 = farg3->ptr ? static_cast< Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg3->ptr) : &tempnull3; - arg4 = farg4->ptr ? static_cast< Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::import_type const > * >(farg4->ptr) : &tempnull4; + smartarg1 = static_cast< Teuchos::RCP< Tpetra::CrsGraph >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::CrsGraph* >(smartarg1->get()) : NULL; + arg2 = farg2->cptr ? static_cast< Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg2->cptr) : &tempnull2; + arg3 = farg3->cptr ? static_cast< Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg3->cptr) : &tempnull3; + arg4 = farg4->cptr ? static_cast< Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::import_type const > * >(farg4->cptr) : &tempnull4; { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::expertStaticFillComplete(Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::import_type const > const &)");; @@ -7383,7 +7431,7 @@ SWIGEXPORT void _wrap_TpetraCrsGraph_expertStaticFillComplete__SWIG_2(SwigClassW SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::expertStaticFillComplete(Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::import_type const > const &)", SWIG_UnknownError, "An unknown exception occurred", return ); } } - + } @@ -7395,10 +7443,10 @@ SWIGEXPORT void _wrap_TpetraCrsGraph_expertStaticFillComplete__SWIG_3(SwigClassW Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > tempnull2 ; Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > tempnull3 ; - smartarg1 = static_cast< Teuchos::RCP< Tpetra::CrsGraph >* >(farg1->ptr); - arg1 = smartarg1 ? smartarg1->get() : NULL; - arg2 = farg2->ptr ? static_cast< Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg2->ptr) : &tempnull2; - arg3 = farg3->ptr ? static_cast< Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg3->ptr) : &tempnull3; + smartarg1 = static_cast< Teuchos::RCP< Tpetra::CrsGraph >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::CrsGraph* >(smartarg1->get()) : NULL; + arg2 = farg2->cptr ? static_cast< Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg2->cptr) : &tempnull2; + arg3 = farg3->cptr ? static_cast< Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg3->cptr) : &tempnull3; { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::expertStaticFillComplete(Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &)");; @@ -7432,8 +7480,8 @@ SWIGEXPORT SwigClassWrapper _wrap_TpetraCrsGraph_getComm(SwigClassWrapper const Teuchos::RCP< Tpetra::CrsGraph< LO,GO,NO > const > *smartarg1 ; Teuchos::RCP< Teuchos::Comm< int > const > result; - smartarg1 = static_cast< Teuchos::RCP >* >(farg1->ptr); - arg1 = smartarg1 ? const_cast*>(smartarg1->get()) : NULL; + smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::CrsGraph* >(smartarg1->get()) : NULL; { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::getComm() const");; @@ -7457,7 +7505,7 @@ SWIGEXPORT SwigClassWrapper _wrap_TpetraCrsGraph_getComm(SwigClassWrapper const SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::getComm() const", SWIG_UnknownError, "An unknown exception occurred", return SwigClassWrapper_uninitialized()); } } - fresult.ptr = (new Teuchos::RCP >(static_cast< const Teuchos::RCP >& >(result))); + fresult.cptr = (new Teuchos::RCP >(static_cast< const Teuchos::RCP >& >(result))); fresult.mem = SWIG_MOVE; return fresult; } @@ -7469,8 +7517,8 @@ SWIGEXPORT SwigClassWrapper _wrap_TpetraCrsGraph_getRowMap(SwigClassWrapper cons Teuchos::RCP< Tpetra::CrsGraph< LO,GO,NO > const > *smartarg1 ; Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > result; - smartarg1 = static_cast< Teuchos::RCP >* >(farg1->ptr); - arg1 = smartarg1 ? const_cast*>(smartarg1->get()) : NULL; + smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::CrsGraph* >(smartarg1->get()) : NULL; { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::getRowMap() const");; @@ -7494,7 +7542,7 @@ SWIGEXPORT SwigClassWrapper _wrap_TpetraCrsGraph_getRowMap(SwigClassWrapper cons SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::getRowMap() const", SWIG_UnknownError, "An unknown exception occurred", return SwigClassWrapper_uninitialized()); } } - fresult.ptr = (new Teuchos::RCP >(static_cast< const Teuchos::RCP >& >(result))); + fresult.cptr = (new Teuchos::RCP >(static_cast< const Teuchos::RCP >& >(result))); fresult.mem = SWIG_MOVE; return fresult; } @@ -7506,8 +7554,8 @@ SWIGEXPORT SwigClassWrapper _wrap_TpetraCrsGraph_getColMap(SwigClassWrapper cons Teuchos::RCP< Tpetra::CrsGraph< LO,GO,NO > const > *smartarg1 ; Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > result; - smartarg1 = static_cast< Teuchos::RCP >* >(farg1->ptr); - arg1 = smartarg1 ? const_cast*>(smartarg1->get()) : NULL; + smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::CrsGraph* >(smartarg1->get()) : NULL; { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::getColMap() const");; @@ -7531,7 +7579,7 @@ SWIGEXPORT SwigClassWrapper _wrap_TpetraCrsGraph_getColMap(SwigClassWrapper cons SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::getColMap() const", SWIG_UnknownError, "An unknown exception occurred", return SwigClassWrapper_uninitialized()); } } - fresult.ptr = (new Teuchos::RCP >(static_cast< const Teuchos::RCP >& >(result))); + fresult.cptr = (new Teuchos::RCP >(static_cast< const Teuchos::RCP >& >(result))); fresult.mem = SWIG_MOVE; return fresult; } @@ -7543,8 +7591,8 @@ SWIGEXPORT SwigClassWrapper _wrap_TpetraCrsGraph_getDomainMap(SwigClassWrapper c Teuchos::RCP< Tpetra::CrsGraph< LO,GO,NO > const > *smartarg1 ; Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > result; - smartarg1 = static_cast< Teuchos::RCP >* >(farg1->ptr); - arg1 = smartarg1 ? const_cast*>(smartarg1->get()) : NULL; + smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::CrsGraph* >(smartarg1->get()) : NULL; { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::getDomainMap() const");; @@ -7568,7 +7616,7 @@ SWIGEXPORT SwigClassWrapper _wrap_TpetraCrsGraph_getDomainMap(SwigClassWrapper c SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::getDomainMap() const", SWIG_UnknownError, "An unknown exception occurred", return SwigClassWrapper_uninitialized()); } } - fresult.ptr = (new Teuchos::RCP >(static_cast< const Teuchos::RCP >& >(result))); + fresult.cptr = (new Teuchos::RCP >(static_cast< const Teuchos::RCP >& >(result))); fresult.mem = SWIG_MOVE; return fresult; } @@ -7580,8 +7628,8 @@ SWIGEXPORT SwigClassWrapper _wrap_TpetraCrsGraph_getRangeMap(SwigClassWrapper co Teuchos::RCP< Tpetra::CrsGraph< LO,GO,NO > const > *smartarg1 ; Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > result; - smartarg1 = static_cast< Teuchos::RCP >* >(farg1->ptr); - arg1 = smartarg1 ? const_cast*>(smartarg1->get()) : NULL; + smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::CrsGraph* >(smartarg1->get()) : NULL; { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::getRangeMap() const");; @@ -7605,7 +7653,7 @@ SWIGEXPORT SwigClassWrapper _wrap_TpetraCrsGraph_getRangeMap(SwigClassWrapper co SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::getRangeMap() const", SWIG_UnknownError, "An unknown exception occurred", return SwigClassWrapper_uninitialized()); } } - fresult.ptr = (new Teuchos::RCP >(static_cast< const Teuchos::RCP >& >(result))); + fresult.cptr = (new Teuchos::RCP >(static_cast< const Teuchos::RCP >& >(result))); fresult.mem = SWIG_MOVE; return fresult; } @@ -7617,8 +7665,8 @@ SWIGEXPORT SwigClassWrapper _wrap_TpetraCrsGraph_getImporter(SwigClassWrapper co Teuchos::RCP< Tpetra::CrsGraph< LO,GO,NO > const > *smartarg1 ; Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::import_type const > result; - smartarg1 = static_cast< Teuchos::RCP >* >(farg1->ptr); - arg1 = smartarg1 ? const_cast*>(smartarg1->get()) : NULL; + smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::CrsGraph* >(smartarg1->get()) : NULL; { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::getImporter() const");; @@ -7642,7 +7690,7 @@ SWIGEXPORT SwigClassWrapper _wrap_TpetraCrsGraph_getImporter(SwigClassWrapper co SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::getImporter() const", SWIG_UnknownError, "An unknown exception occurred", return SwigClassWrapper_uninitialized()); } } - fresult.ptr = (new Teuchos::RCP >(static_cast< const Teuchos::RCP >& >(result))); + fresult.cptr = (new Teuchos::RCP >(static_cast< const Teuchos::RCP >& >(result))); fresult.mem = SWIG_MOVE; return fresult; } @@ -7654,8 +7702,8 @@ SWIGEXPORT SwigClassWrapper _wrap_TpetraCrsGraph_getExporter(SwigClassWrapper co Teuchos::RCP< Tpetra::CrsGraph< LO,GO,NO > const > *smartarg1 ; Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::export_type const > result; - smartarg1 = static_cast< Teuchos::RCP >* >(farg1->ptr); - arg1 = smartarg1 ? const_cast*>(smartarg1->get()) : NULL; + smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::CrsGraph* >(smartarg1->get()) : NULL; { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::getExporter() const");; @@ -7679,20 +7727,20 @@ SWIGEXPORT SwigClassWrapper _wrap_TpetraCrsGraph_getExporter(SwigClassWrapper co SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::getExporter() const", SWIG_UnknownError, "An unknown exception occurred", return SwigClassWrapper_uninitialized()); } } - fresult.ptr = (new Teuchos::RCP >(static_cast< const Teuchos::RCP >& >(result))); + fresult.cptr = (new Teuchos::RCP >(static_cast< const Teuchos::RCP >& >(result))); fresult.mem = SWIG_MOVE; return fresult; } -SWIGEXPORT unsigned long _wrap_TpetraCrsGraph_getGlobalNumRows(SwigClassWrapper const *farg1) { - unsigned long fresult ; +SWIGEXPORT long _wrap_TpetraCrsGraph_getGlobalNumRows(SwigClassWrapper const *farg1) { + long fresult ; Tpetra::CrsGraph< LO,GO,NO > *arg1 = (Tpetra::CrsGraph< LO,GO,NO > *) 0 ; Teuchos::RCP< Tpetra::CrsGraph< LO,GO,NO > const > *smartarg1 ; Tpetra::global_size_t result; - smartarg1 = static_cast< Teuchos::RCP >* >(farg1->ptr); - arg1 = smartarg1 ? const_cast*>(smartarg1->get()) : NULL; + smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::CrsGraph* >(smartarg1->get()) : NULL; { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::getGlobalNumRows() const");; @@ -7716,19 +7764,19 @@ SWIGEXPORT unsigned long _wrap_TpetraCrsGraph_getGlobalNumRows(SwigClassWrapper SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::getGlobalNumRows() const", SWIG_UnknownError, "An unknown exception occurred", return 0); } } - fresult = result; + fresult = static_cast< Tpetra::global_size_t >(result); return fresult; } -SWIGEXPORT unsigned long _wrap_TpetraCrsGraph_getGlobalNumCols(SwigClassWrapper const *farg1) { - unsigned long fresult ; +SWIGEXPORT long _wrap_TpetraCrsGraph_getGlobalNumCols(SwigClassWrapper const *farg1) { + long fresult ; Tpetra::CrsGraph< LO,GO,NO > *arg1 = (Tpetra::CrsGraph< LO,GO,NO > *) 0 ; Teuchos::RCP< Tpetra::CrsGraph< LO,GO,NO > const > *smartarg1 ; Tpetra::global_size_t result; - smartarg1 = static_cast< Teuchos::RCP >* >(farg1->ptr); - arg1 = smartarg1 ? const_cast*>(smartarg1->get()) : NULL; + smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::CrsGraph* >(smartarg1->get()) : NULL; { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::getGlobalNumCols() const");; @@ -7752,7 +7800,7 @@ SWIGEXPORT unsigned long _wrap_TpetraCrsGraph_getGlobalNumCols(SwigClassWrapper SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::getGlobalNumCols() const", SWIG_UnknownError, "An unknown exception occurred", return 0); } } - fresult = result; + fresult = static_cast< Tpetra::global_size_t >(result); return fresult; } @@ -7763,8 +7811,8 @@ SWIGEXPORT size_t _wrap_TpetraCrsGraph_getNodeNumRows(SwigClassWrapper const *fa Teuchos::RCP< Tpetra::CrsGraph< LO,GO,NO > const > *smartarg1 ; size_t result; - smartarg1 = static_cast< Teuchos::RCP >* >(farg1->ptr); - arg1 = smartarg1 ? const_cast*>(smartarg1->get()) : NULL; + smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::CrsGraph* >(smartarg1->get()) : NULL; { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::getNodeNumRows() const");; @@ -7788,7 +7836,7 @@ SWIGEXPORT size_t _wrap_TpetraCrsGraph_getNodeNumRows(SwigClassWrapper const *fa SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::getNodeNumRows() const", SWIG_UnknownError, "An unknown exception occurred", return 0); } } - fresult = result; + fresult = static_cast< size_t >(result); return fresult; } @@ -7799,8 +7847,8 @@ SWIGEXPORT size_t _wrap_TpetraCrsGraph_getNodeNumCols(SwigClassWrapper const *fa Teuchos::RCP< Tpetra::CrsGraph< LO,GO,NO > const > *smartarg1 ; size_t result; - smartarg1 = static_cast< Teuchos::RCP >* >(farg1->ptr); - arg1 = smartarg1 ? const_cast*>(smartarg1->get()) : NULL; + smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::CrsGraph* >(smartarg1->get()) : NULL; { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::getNodeNumCols() const");; @@ -7824,19 +7872,19 @@ SWIGEXPORT size_t _wrap_TpetraCrsGraph_getNodeNumCols(SwigClassWrapper const *fa SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::getNodeNumCols() const", SWIG_UnknownError, "An unknown exception occurred", return 0); } } - fresult = result; + fresult = static_cast< size_t >(result); return fresult; } -SWIGEXPORT unsigned long _wrap_TpetraCrsGraph_getGlobalNumEntries(SwigClassWrapper const *farg1) { - unsigned long fresult ; +SWIGEXPORT long _wrap_TpetraCrsGraph_getGlobalNumEntries(SwigClassWrapper const *farg1) { + long fresult ; Tpetra::CrsGraph< LO,GO,NO > *arg1 = (Tpetra::CrsGraph< LO,GO,NO > *) 0 ; Teuchos::RCP< Tpetra::CrsGraph< LO,GO,NO > const > *smartarg1 ; Tpetra::global_size_t result; - smartarg1 = static_cast< Teuchos::RCP >* >(farg1->ptr); - arg1 = smartarg1 ? const_cast*>(smartarg1->get()) : NULL; + smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::CrsGraph* >(smartarg1->get()) : NULL; { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::getGlobalNumEntries() const");; @@ -7860,7 +7908,7 @@ SWIGEXPORT unsigned long _wrap_TpetraCrsGraph_getGlobalNumEntries(SwigClassWrapp SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::getGlobalNumEntries() const", SWIG_UnknownError, "An unknown exception occurred", return 0); } } - fresult = result; + fresult = static_cast< Tpetra::global_size_t >(result); return fresult; } @@ -7871,8 +7919,8 @@ SWIGEXPORT size_t _wrap_TpetraCrsGraph_getNodeNumEntries(SwigClassWrapper const Teuchos::RCP< Tpetra::CrsGraph< LO,GO,NO > const > *smartarg1 ; size_t result; - smartarg1 = static_cast< Teuchos::RCP >* >(farg1->ptr); - arg1 = smartarg1 ? const_cast*>(smartarg1->get()) : NULL; + smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::CrsGraph* >(smartarg1->get()) : NULL; { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::getNodeNumEntries() const");; @@ -7896,7 +7944,7 @@ SWIGEXPORT size_t _wrap_TpetraCrsGraph_getNodeNumEntries(SwigClassWrapper const SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::getNodeNumEntries() const", SWIG_UnknownError, "An unknown exception occurred", return 0); } } - fresult = result; + fresult = static_cast< size_t >(result); return fresult; } @@ -7908,9 +7956,9 @@ SWIGEXPORT size_t _wrap_TpetraCrsGraph_getNumEntriesInGlobalRow(SwigClassWrapper Teuchos::RCP< Tpetra::CrsGraph< LO,GO,NO > const > *smartarg1 ; size_t result; - smartarg1 = static_cast< Teuchos::RCP >* >(farg1->ptr); - arg1 = smartarg1 ? const_cast*>(smartarg1->get()) : NULL; - arg2 = *farg2; + smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::CrsGraph* >(smartarg1->get()) : NULL; + arg2 = static_cast< long long >(*farg2); { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::getNumEntriesInGlobalRow(long long) const");; @@ -7934,7 +7982,7 @@ SWIGEXPORT size_t _wrap_TpetraCrsGraph_getNumEntriesInGlobalRow(SwigClassWrapper SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::getNumEntriesInGlobalRow(long long) const", SWIG_UnknownError, "An unknown exception occurred", return 0); } } - fresult = result; + fresult = static_cast< size_t >(result); return fresult; } @@ -7946,8 +7994,8 @@ SWIGEXPORT size_t _wrap_TpetraCrsGraph_getNumEntriesInLocalRow(SwigClassWrapper Teuchos::RCP< Tpetra::CrsGraph< LO,GO,NO > const > *smartarg1 ; size_t result; - smartarg1 = static_cast< Teuchos::RCP >* >(farg1->ptr); - arg1 = smartarg1 ? const_cast*>(smartarg1->get()) : NULL; + smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::CrsGraph* >(smartarg1->get()) : NULL; arg2 = *farg2 - 1; { // Make sure no unhandled exceptions exist before performing a new action @@ -7972,7 +8020,7 @@ SWIGEXPORT size_t _wrap_TpetraCrsGraph_getNumEntriesInLocalRow(SwigClassWrapper SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::getNumEntriesInLocalRow(int) const", SWIG_UnknownError, "An unknown exception occurred", return 0); } } - fresult = result; + fresult = static_cast< size_t >(result); return fresult; } @@ -7983,8 +8031,8 @@ SWIGEXPORT size_t _wrap_TpetraCrsGraph_getNodeAllocationSize(SwigClassWrapper co Teuchos::RCP< Tpetra::CrsGraph< LO,GO,NO > const > *smartarg1 ; size_t result; - smartarg1 = static_cast< Teuchos::RCP >* >(farg1->ptr); - arg1 = smartarg1 ? const_cast*>(smartarg1->get()) : NULL; + smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::CrsGraph* >(smartarg1->get()) : NULL; { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::getNodeAllocationSize() const");; @@ -8008,7 +8056,7 @@ SWIGEXPORT size_t _wrap_TpetraCrsGraph_getNodeAllocationSize(SwigClassWrapper co SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::getNodeAllocationSize() const", SWIG_UnknownError, "An unknown exception occurred", return 0); } } - fresult = result; + fresult = static_cast< size_t >(result); return fresult; } @@ -8020,9 +8068,9 @@ SWIGEXPORT size_t _wrap_TpetraCrsGraph_getNumAllocatedEntriesInGlobalRow(SwigCla Teuchos::RCP< Tpetra::CrsGraph< LO,GO,NO > const > *smartarg1 ; size_t result; - smartarg1 = static_cast< Teuchos::RCP >* >(farg1->ptr); - arg1 = smartarg1 ? const_cast*>(smartarg1->get()) : NULL; - arg2 = *farg2; + smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::CrsGraph* >(smartarg1->get()) : NULL; + arg2 = static_cast< long long >(*farg2); { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::getNumAllocatedEntriesInGlobalRow(long long) const");; @@ -8046,7 +8094,7 @@ SWIGEXPORT size_t _wrap_TpetraCrsGraph_getNumAllocatedEntriesInGlobalRow(SwigCla SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::getNumAllocatedEntriesInGlobalRow(long long) const", SWIG_UnknownError, "An unknown exception occurred", return 0); } } - fresult = result; + fresult = static_cast< size_t >(result); return fresult; } @@ -8058,8 +8106,8 @@ SWIGEXPORT size_t _wrap_TpetraCrsGraph_getNumAllocatedEntriesInLocalRow(SwigClas Teuchos::RCP< Tpetra::CrsGraph< LO,GO,NO > const > *smartarg1 ; size_t result; - smartarg1 = static_cast< Teuchos::RCP >* >(farg1->ptr); - arg1 = smartarg1 ? const_cast*>(smartarg1->get()) : NULL; + smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::CrsGraph* >(smartarg1->get()) : NULL; arg2 = *farg2 - 1; { // Make sure no unhandled exceptions exist before performing a new action @@ -8084,19 +8132,19 @@ SWIGEXPORT size_t _wrap_TpetraCrsGraph_getNumAllocatedEntriesInLocalRow(SwigClas SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::getNumAllocatedEntriesInLocalRow(int) const", SWIG_UnknownError, "An unknown exception occurred", return 0); } } - fresult = result; + fresult = static_cast< size_t >(result); return fresult; } -SWIGEXPORT unsigned long _wrap_TpetraCrsGraph_getGlobalNumDiags(SwigClassWrapper const *farg1) { - unsigned long fresult ; +SWIGEXPORT long _wrap_TpetraCrsGraph_getGlobalNumDiags(SwigClassWrapper const *farg1) { + long fresult ; Tpetra::CrsGraph< LO,GO,NO > *arg1 = (Tpetra::CrsGraph< LO,GO,NO > *) 0 ; Teuchos::RCP< Tpetra::CrsGraph< LO,GO,NO > const > *smartarg1 ; Tpetra::global_size_t result; - smartarg1 = static_cast< Teuchos::RCP >* >(farg1->ptr); - arg1 = smartarg1 ? const_cast*>(smartarg1->get()) : NULL; + smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::CrsGraph* >(smartarg1->get()) : NULL; { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::getGlobalNumDiags() const");; @@ -8120,19 +8168,19 @@ SWIGEXPORT unsigned long _wrap_TpetraCrsGraph_getGlobalNumDiags(SwigClassWrapper SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::getGlobalNumDiags() const", SWIG_UnknownError, "An unknown exception occurred", return 0); } } - fresult = result; + fresult = static_cast< Tpetra::global_size_t >(result); return fresult; } -SWIGEXPORT unsigned long _wrap_TpetraCrsGraph_getGlobalNumDiagsImpl(SwigClassWrapper const *farg1) { - unsigned long fresult ; +SWIGEXPORT long _wrap_TpetraCrsGraph_getGlobalNumDiagsImpl(SwigClassWrapper const *farg1) { + long fresult ; Tpetra::CrsGraph< LO,GO,NO > *arg1 = (Tpetra::CrsGraph< LO,GO,NO > *) 0 ; Teuchos::RCP< Tpetra::CrsGraph< LO,GO,NO > const > *smartarg1 ; Tpetra::global_size_t result; - smartarg1 = static_cast< Teuchos::RCP >* >(farg1->ptr); - arg1 = smartarg1 ? const_cast*>(smartarg1->get()) : NULL; + smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::CrsGraph* >(smartarg1->get()) : NULL; { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::getGlobalNumDiagsImpl() const");; @@ -8156,7 +8204,7 @@ SWIGEXPORT unsigned long _wrap_TpetraCrsGraph_getGlobalNumDiagsImpl(SwigClassWra SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::getGlobalNumDiagsImpl() const", SWIG_UnknownError, "An unknown exception occurred", return 0); } } - fresult = result; + fresult = static_cast< Tpetra::global_size_t >(result); return fresult; } @@ -8167,8 +8215,8 @@ SWIGEXPORT size_t _wrap_TpetraCrsGraph_getNodeNumDiags(SwigClassWrapper const *f Teuchos::RCP< Tpetra::CrsGraph< LO,GO,NO > const > *smartarg1 ; size_t result; - smartarg1 = static_cast< Teuchos::RCP >* >(farg1->ptr); - arg1 = smartarg1 ? const_cast*>(smartarg1->get()) : NULL; + smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::CrsGraph* >(smartarg1->get()) : NULL; { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::getNodeNumDiags() const");; @@ -8192,7 +8240,7 @@ SWIGEXPORT size_t _wrap_TpetraCrsGraph_getNodeNumDiags(SwigClassWrapper const *f SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::getNodeNumDiags() const", SWIG_UnknownError, "An unknown exception occurred", return 0); } } - fresult = result; + fresult = static_cast< size_t >(result); return fresult; } @@ -8203,8 +8251,8 @@ SWIGEXPORT size_t _wrap_TpetraCrsGraph_getNodeNumDiagsImpl(SwigClassWrapper cons Teuchos::RCP< Tpetra::CrsGraph< LO,GO,NO > const > *smartarg1 ; size_t result; - smartarg1 = static_cast< Teuchos::RCP >* >(farg1->ptr); - arg1 = smartarg1 ? const_cast*>(smartarg1->get()) : NULL; + smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::CrsGraph* >(smartarg1->get()) : NULL; { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::getNodeNumDiagsImpl() const");; @@ -8228,7 +8276,7 @@ SWIGEXPORT size_t _wrap_TpetraCrsGraph_getNodeNumDiagsImpl(SwigClassWrapper cons SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::getNodeNumDiagsImpl() const", SWIG_UnknownError, "An unknown exception occurred", return 0); } } - fresult = result; + fresult = static_cast< size_t >(result); return fresult; } @@ -8239,8 +8287,8 @@ SWIGEXPORT size_t _wrap_TpetraCrsGraph_getGlobalMaxNumRowEntries(SwigClassWrappe Teuchos::RCP< Tpetra::CrsGraph< LO,GO,NO > const > *smartarg1 ; size_t result; - smartarg1 = static_cast< Teuchos::RCP >* >(farg1->ptr); - arg1 = smartarg1 ? const_cast*>(smartarg1->get()) : NULL; + smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::CrsGraph* >(smartarg1->get()) : NULL; { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::getGlobalMaxNumRowEntries() const");; @@ -8264,7 +8312,7 @@ SWIGEXPORT size_t _wrap_TpetraCrsGraph_getGlobalMaxNumRowEntries(SwigClassWrappe SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::getGlobalMaxNumRowEntries() const", SWIG_UnknownError, "An unknown exception occurred", return 0); } } - fresult = result; + fresult = static_cast< size_t >(result); return fresult; } @@ -8275,8 +8323,8 @@ SWIGEXPORT size_t _wrap_TpetraCrsGraph_getNodeMaxNumRowEntries(SwigClassWrapper Teuchos::RCP< Tpetra::CrsGraph< LO,GO,NO > const > *smartarg1 ; size_t result; - smartarg1 = static_cast< Teuchos::RCP >* >(farg1->ptr); - arg1 = smartarg1 ? const_cast*>(smartarg1->get()) : NULL; + smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::CrsGraph* >(smartarg1->get()) : NULL; { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::getNodeMaxNumRowEntries() const");; @@ -8300,7 +8348,7 @@ SWIGEXPORT size_t _wrap_TpetraCrsGraph_getNodeMaxNumRowEntries(SwigClassWrapper SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::getNodeMaxNumRowEntries() const", SWIG_UnknownError, "An unknown exception occurred", return 0); } } - fresult = result; + fresult = static_cast< size_t >(result); return fresult; } @@ -8311,8 +8359,8 @@ SWIGEXPORT bool _wrap_TpetraCrsGraph_hasColMap(SwigClassWrapper const *farg1) { Teuchos::RCP< Tpetra::CrsGraph< LO,GO,NO > const > *smartarg1 ; bool result; - smartarg1 = static_cast< Teuchos::RCP >* >(farg1->ptr); - arg1 = smartarg1 ? const_cast*>(smartarg1->get()) : NULL; + smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::CrsGraph* >(smartarg1->get()) : NULL; { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::hasColMap() const");; @@ -8336,7 +8384,7 @@ SWIGEXPORT bool _wrap_TpetraCrsGraph_hasColMap(SwigClassWrapper const *farg1) { SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::hasColMap() const", SWIG_UnknownError, "An unknown exception occurred", return 0); } } - fresult = result; + fresult = static_cast< bool >(result); return fresult; } @@ -8347,8 +8395,8 @@ SWIGEXPORT bool _wrap_TpetraCrsGraph_isLowerTriangularImpl(SwigClassWrapper cons Teuchos::RCP< Tpetra::CrsGraph< LO,GO,NO > const > *smartarg1 ; bool result; - smartarg1 = static_cast< Teuchos::RCP >* >(farg1->ptr); - arg1 = smartarg1 ? const_cast*>(smartarg1->get()) : NULL; + smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::CrsGraph* >(smartarg1->get()) : NULL; { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::isLowerTriangularImpl() const");; @@ -8372,7 +8420,7 @@ SWIGEXPORT bool _wrap_TpetraCrsGraph_isLowerTriangularImpl(SwigClassWrapper cons SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::isLowerTriangularImpl() const", SWIG_UnknownError, "An unknown exception occurred", return 0); } } - fresult = result; + fresult = static_cast< bool >(result); return fresult; } @@ -8383,8 +8431,8 @@ SWIGEXPORT bool _wrap_TpetraCrsGraph_isLowerTriangular(SwigClassWrapper const *f Teuchos::RCP< Tpetra::CrsGraph< LO,GO,NO > const > *smartarg1 ; bool result; - smartarg1 = static_cast< Teuchos::RCP >* >(farg1->ptr); - arg1 = smartarg1 ? const_cast*>(smartarg1->get()) : NULL; + smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::CrsGraph* >(smartarg1->get()) : NULL; { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::isLowerTriangular() const");; @@ -8408,7 +8456,7 @@ SWIGEXPORT bool _wrap_TpetraCrsGraph_isLowerTriangular(SwigClassWrapper const *f SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::isLowerTriangular() const", SWIG_UnknownError, "An unknown exception occurred", return 0); } } - fresult = result; + fresult = static_cast< bool >(result); return fresult; } @@ -8419,8 +8467,8 @@ SWIGEXPORT bool _wrap_TpetraCrsGraph_isUpperTriangularImpl(SwigClassWrapper cons Teuchos::RCP< Tpetra::CrsGraph< LO,GO,NO > const > *smartarg1 ; bool result; - smartarg1 = static_cast< Teuchos::RCP >* >(farg1->ptr); - arg1 = smartarg1 ? const_cast*>(smartarg1->get()) : NULL; + smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::CrsGraph* >(smartarg1->get()) : NULL; { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::isUpperTriangularImpl() const");; @@ -8444,7 +8492,7 @@ SWIGEXPORT bool _wrap_TpetraCrsGraph_isUpperTriangularImpl(SwigClassWrapper cons SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::isUpperTriangularImpl() const", SWIG_UnknownError, "An unknown exception occurred", return 0); } } - fresult = result; + fresult = static_cast< bool >(result); return fresult; } @@ -8455,8 +8503,8 @@ SWIGEXPORT bool _wrap_TpetraCrsGraph_isUpperTriangular(SwigClassWrapper const *f Teuchos::RCP< Tpetra::CrsGraph< LO,GO,NO > const > *smartarg1 ; bool result; - smartarg1 = static_cast< Teuchos::RCP >* >(farg1->ptr); - arg1 = smartarg1 ? const_cast*>(smartarg1->get()) : NULL; + smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::CrsGraph* >(smartarg1->get()) : NULL; { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::isUpperTriangular() const");; @@ -8480,7 +8528,7 @@ SWIGEXPORT bool _wrap_TpetraCrsGraph_isUpperTriangular(SwigClassWrapper const *f SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::isUpperTriangular() const", SWIG_UnknownError, "An unknown exception occurred", return 0); } } - fresult = result; + fresult = static_cast< bool >(result); return fresult; } @@ -8491,8 +8539,8 @@ SWIGEXPORT bool _wrap_TpetraCrsGraph_isLocallyIndexed(SwigClassWrapper const *fa Teuchos::RCP< Tpetra::CrsGraph< LO,GO,NO > const > *smartarg1 ; bool result; - smartarg1 = static_cast< Teuchos::RCP >* >(farg1->ptr); - arg1 = smartarg1 ? const_cast*>(smartarg1->get()) : NULL; + smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::CrsGraph* >(smartarg1->get()) : NULL; { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::isLocallyIndexed() const");; @@ -8516,7 +8564,7 @@ SWIGEXPORT bool _wrap_TpetraCrsGraph_isLocallyIndexed(SwigClassWrapper const *fa SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::isLocallyIndexed() const", SWIG_UnknownError, "An unknown exception occurred", return 0); } } - fresult = result; + fresult = static_cast< bool >(result); return fresult; } @@ -8527,8 +8575,8 @@ SWIGEXPORT bool _wrap_TpetraCrsGraph_isGloballyIndexed(SwigClassWrapper const *f Teuchos::RCP< Tpetra::CrsGraph< LO,GO,NO > const > *smartarg1 ; bool result; - smartarg1 = static_cast< Teuchos::RCP >* >(farg1->ptr); - arg1 = smartarg1 ? const_cast*>(smartarg1->get()) : NULL; + smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::CrsGraph* >(smartarg1->get()) : NULL; { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::isGloballyIndexed() const");; @@ -8552,7 +8600,7 @@ SWIGEXPORT bool _wrap_TpetraCrsGraph_isGloballyIndexed(SwigClassWrapper const *f SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::isGloballyIndexed() const", SWIG_UnknownError, "An unknown exception occurred", return 0); } } - fresult = result; + fresult = static_cast< bool >(result); return fresult; } @@ -8563,8 +8611,8 @@ SWIGEXPORT bool _wrap_TpetraCrsGraph_isFillComplete(SwigClassWrapper const *farg Teuchos::RCP< Tpetra::CrsGraph< LO,GO,NO > const > *smartarg1 ; bool result; - smartarg1 = static_cast< Teuchos::RCP >* >(farg1->ptr); - arg1 = smartarg1 ? const_cast*>(smartarg1->get()) : NULL; + smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::CrsGraph* >(smartarg1->get()) : NULL; { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::isFillComplete() const");; @@ -8588,7 +8636,7 @@ SWIGEXPORT bool _wrap_TpetraCrsGraph_isFillComplete(SwigClassWrapper const *farg SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::isFillComplete() const", SWIG_UnknownError, "An unknown exception occurred", return 0); } } - fresult = result; + fresult = static_cast< bool >(result); return fresult; } @@ -8599,8 +8647,8 @@ SWIGEXPORT bool _wrap_TpetraCrsGraph_isFillActive(SwigClassWrapper const *farg1) Teuchos::RCP< Tpetra::CrsGraph< LO,GO,NO > const > *smartarg1 ; bool result; - smartarg1 = static_cast< Teuchos::RCP >* >(farg1->ptr); - arg1 = smartarg1 ? const_cast*>(smartarg1->get()) : NULL; + smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::CrsGraph* >(smartarg1->get()) : NULL; { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::isFillActive() const");; @@ -8624,7 +8672,7 @@ SWIGEXPORT bool _wrap_TpetraCrsGraph_isFillActive(SwigClassWrapper const *farg1) SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::isFillActive() const", SWIG_UnknownError, "An unknown exception occurred", return 0); } } - fresult = result; + fresult = static_cast< bool >(result); return fresult; } @@ -8635,8 +8683,8 @@ SWIGEXPORT bool _wrap_TpetraCrsGraph_isSorted(SwigClassWrapper const *farg1) { Teuchos::RCP< Tpetra::CrsGraph< LO,GO,NO > const > *smartarg1 ; bool result; - smartarg1 = static_cast< Teuchos::RCP >* >(farg1->ptr); - arg1 = smartarg1 ? const_cast*>(smartarg1->get()) : NULL; + smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::CrsGraph* >(smartarg1->get()) : NULL; { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::isSorted() const");; @@ -8660,7 +8708,7 @@ SWIGEXPORT bool _wrap_TpetraCrsGraph_isSorted(SwigClassWrapper const *farg1) { SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::isSorted() const", SWIG_UnknownError, "An unknown exception occurred", return 0); } } - fresult = result; + fresult = static_cast< bool >(result); return fresult; } @@ -8671,8 +8719,8 @@ SWIGEXPORT bool _wrap_TpetraCrsGraph_isStorageOptimized(SwigClassWrapper const * Teuchos::RCP< Tpetra::CrsGraph< LO,GO,NO > const > *smartarg1 ; bool result; - smartarg1 = static_cast< Teuchos::RCP >* >(farg1->ptr); - arg1 = smartarg1 ? const_cast*>(smartarg1->get()) : NULL; + smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::CrsGraph* >(smartarg1->get()) : NULL; { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::isStorageOptimized() const");; @@ -8696,7 +8744,7 @@ SWIGEXPORT bool _wrap_TpetraCrsGraph_isStorageOptimized(SwigClassWrapper const * SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::isStorageOptimized() const", SWIG_UnknownError, "An unknown exception occurred", return 0); } } - fresult = result; + fresult = static_cast< bool >(result); return fresult; } @@ -8707,8 +8755,8 @@ SWIGEXPORT int _wrap_TpetraCrsGraph_getProfileType(SwigClassWrapper const *farg1 Teuchos::RCP< Tpetra::CrsGraph< LO,GO,NO > const > *smartarg1 ; Tpetra::ProfileType result; - smartarg1 = static_cast< Teuchos::RCP >* >(farg1->ptr); - arg1 = smartarg1 ? const_cast*>(smartarg1->get()) : NULL; + smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::CrsGraph* >(smartarg1->get()) : NULL; { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::getProfileType() const");; @@ -8743,8 +8791,8 @@ SWIGEXPORT bool _wrap_TpetraCrsGraph_supportsRowViews(SwigClassWrapper const *fa Teuchos::RCP< Tpetra::CrsGraph< LO,GO,NO > const > *smartarg1 ; bool result; - smartarg1 = static_cast< Teuchos::RCP >* >(farg1->ptr); - arg1 = smartarg1 ? const_cast*>(smartarg1->get()) : NULL; + smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::CrsGraph* >(smartarg1->get()) : NULL; { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::supportsRowViews() const");; @@ -8768,7 +8816,7 @@ SWIGEXPORT bool _wrap_TpetraCrsGraph_supportsRowViews(SwigClassWrapper const *fa SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::supportsRowViews() const", SWIG_UnknownError, "An unknown exception occurred", return 0); } } - fresult = result; + fresult = static_cast< bool >(result); return fresult; } @@ -8779,8 +8827,8 @@ SWIGEXPORT SwigArrayWrapper _wrap_TpetraCrsGraph_description(SwigClassWrapper co Teuchos::RCP< Tpetra::CrsGraph< LO,GO,NO > const > *smartarg1 ; std::string result; - smartarg1 = static_cast< Teuchos::RCP >* >(farg1->ptr); - arg1 = smartarg1 ? const_cast*>(smartarg1->get()) : NULL; + smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::CrsGraph* >(smartarg1->get()) : NULL; { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::description() const");; @@ -8821,9 +8869,9 @@ SWIGEXPORT void _wrap_TpetraCrsGraph_replaceColMap(SwigClassWrapper const *farg1 Teuchos::RCP< Tpetra::CrsGraph< LO,GO,NO > > *smartarg1 ; Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > tempnull2 ; - smartarg1 = static_cast< Teuchos::RCP< Tpetra::CrsGraph >* >(farg1->ptr); - arg1 = smartarg1 ? smartarg1->get() : NULL; - arg2 = farg2->ptr ? static_cast< Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg2->ptr) : &tempnull2; + smartarg1 = static_cast< Teuchos::RCP< Tpetra::CrsGraph >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::CrsGraph* >(smartarg1->get()) : NULL; + arg2 = farg2->cptr ? static_cast< Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg2->cptr) : &tempnull2; { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::replaceColMap(Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &)");; @@ -8847,7 +8895,7 @@ SWIGEXPORT void _wrap_TpetraCrsGraph_replaceColMap(SwigClassWrapper const *farg1 SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::replaceColMap(Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &)", SWIG_UnknownError, "An unknown exception occurred", return ); } } - + } @@ -8860,11 +8908,11 @@ SWIGEXPORT void _wrap_TpetraCrsGraph_reindexColumns__SWIG_0(SwigClassWrapper con Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > tempnull2 ; Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::import_type const > tempnull3 ; - smartarg1 = static_cast< Teuchos::RCP< Tpetra::CrsGraph >* >(farg1->ptr); - arg1 = smartarg1 ? smartarg1->get() : NULL; - arg2 = farg2->ptr ? static_cast< Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg2->ptr) : &tempnull2; - arg3 = farg3->ptr ? static_cast< Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::import_type const > * >(farg3->ptr) : &tempnull3; - arg4 = *farg4; + smartarg1 = static_cast< Teuchos::RCP< Tpetra::CrsGraph >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::CrsGraph* >(smartarg1->get()) : NULL; + arg2 = farg2->cptr ? static_cast< Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg2->cptr) : &tempnull2; + arg3 = farg3->cptr ? static_cast< Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::import_type const > * >(farg3->cptr) : &tempnull3; + arg4 = static_cast< bool >(*farg4); { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::reindexColumns(Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::import_type const > const &,bool const)");; @@ -8888,7 +8936,7 @@ SWIGEXPORT void _wrap_TpetraCrsGraph_reindexColumns__SWIG_0(SwigClassWrapper con SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::reindexColumns(Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::import_type const > const &,bool const)", SWIG_UnknownError, "An unknown exception occurred", return ); } } - + } @@ -8900,10 +8948,10 @@ SWIGEXPORT void _wrap_TpetraCrsGraph_reindexColumns__SWIG_1(SwigClassWrapper con Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > tempnull2 ; Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::import_type const > tempnull3 ; - smartarg1 = static_cast< Teuchos::RCP< Tpetra::CrsGraph >* >(farg1->ptr); - arg1 = smartarg1 ? smartarg1->get() : NULL; - arg2 = farg2->ptr ? static_cast< Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg2->ptr) : &tempnull2; - arg3 = farg3->ptr ? static_cast< Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::import_type const > * >(farg3->ptr) : &tempnull3; + smartarg1 = static_cast< Teuchos::RCP< Tpetra::CrsGraph >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::CrsGraph* >(smartarg1->get()) : NULL; + arg2 = farg2->cptr ? static_cast< Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg2->cptr) : &tempnull2; + arg3 = farg3->cptr ? static_cast< Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::import_type const > * >(farg3->cptr) : &tempnull3; { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::reindexColumns(Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::import_type const > const &)");; @@ -8927,7 +8975,7 @@ SWIGEXPORT void _wrap_TpetraCrsGraph_reindexColumns__SWIG_1(SwigClassWrapper con SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::reindexColumns(Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::import_type const > const &)", SWIG_UnknownError, "An unknown exception occurred", return ); } } - + } @@ -8937,9 +8985,9 @@ SWIGEXPORT void _wrap_TpetraCrsGraph_reindexColumns__SWIG_2(SwigClassWrapper con Teuchos::RCP< Tpetra::CrsGraph< LO,GO,NO > > *smartarg1 ; Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > tempnull2 ; - smartarg1 = static_cast< Teuchos::RCP< Tpetra::CrsGraph >* >(farg1->ptr); - arg1 = smartarg1 ? smartarg1->get() : NULL; - arg2 = farg2->ptr ? static_cast< Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg2->ptr) : &tempnull2; + smartarg1 = static_cast< Teuchos::RCP< Tpetra::CrsGraph >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::CrsGraph* >(smartarg1->get()) : NULL; + arg2 = farg2->cptr ? static_cast< Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg2->cptr) : &tempnull2; { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::reindexColumns(Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &)");; @@ -8963,7 +9011,7 @@ SWIGEXPORT void _wrap_TpetraCrsGraph_reindexColumns__SWIG_2(SwigClassWrapper con SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::reindexColumns(Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &)", SWIG_UnknownError, "An unknown exception occurred", return ); } } - + } @@ -8975,10 +9023,10 @@ SWIGEXPORT void _wrap_TpetraCrsGraph_replaceDomainMapAndImporter(SwigClassWrappe Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > tempnull2 ; Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::import_type const > tempnull3 ; - smartarg1 = static_cast< Teuchos::RCP< Tpetra::CrsGraph >* >(farg1->ptr); - arg1 = smartarg1 ? smartarg1->get() : NULL; - arg2 = farg2->ptr ? static_cast< Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg2->ptr) : &tempnull2; - arg3 = farg3->ptr ? static_cast< Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::import_type const > * >(farg3->ptr) : &tempnull3; + smartarg1 = static_cast< Teuchos::RCP< Tpetra::CrsGraph >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::CrsGraph* >(smartarg1->get()) : NULL; + arg2 = farg2->cptr ? static_cast< Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg2->cptr) : &tempnull2; + arg3 = farg3->cptr ? static_cast< Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::import_type const > * >(farg3->cptr) : &tempnull3; { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::replaceDomainMapAndImporter(Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::import_type const > const &)");; @@ -9002,7 +9050,7 @@ SWIGEXPORT void _wrap_TpetraCrsGraph_replaceDomainMapAndImporter(SwigClassWrappe SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::replaceDomainMapAndImporter(Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::import_type const > const &)", SWIG_UnknownError, "An unknown exception occurred", return ); } } - + } @@ -9011,10 +9059,10 @@ SWIGEXPORT void _wrap_TpetraCrsGraph_removeEmptyProcessesInPlace(SwigClassWrappe Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > *arg2 = 0 ; Teuchos::RCP< Tpetra::CrsGraph< LO,GO,NO > > *smartarg1 ; Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > tempnull2 ; - - smartarg1 = static_cast< Teuchos::RCP< Tpetra::CrsGraph >* >(farg1->ptr); - arg1 = smartarg1 ? smartarg1->get() : NULL; - arg2 = farg2->ptr ? static_cast< Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg2->ptr) : &tempnull2; + + smartarg1 = static_cast< Teuchos::RCP< Tpetra::CrsGraph >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::CrsGraph* >(smartarg1->get()) : NULL; + arg2 = farg2->cptr ? static_cast< Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg2->cptr) : &tempnull2; { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::removeEmptyProcessesInPlace(Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &)");; @@ -9038,7 +9086,7 @@ SWIGEXPORT void _wrap_TpetraCrsGraph_removeEmptyProcessesInPlace(SwigClassWrappe SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::removeEmptyProcessesInPlace(Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &)", SWIG_UnknownError, "An unknown exception occurred", return ); } } - + } @@ -9056,15 +9104,15 @@ SWIGEXPORT void _wrap_TpetraCrsGraph_importAndFillComplete__SWIG_0(SwigClassWrap Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > tempnull5 ; Teuchos::RCP< Teuchos::ParameterList > tempnull6 ; - smartarg1 = static_cast< Teuchos::RCP >* >(farg1->ptr); - arg1 = smartarg1 ? const_cast*>(smartarg1->get()) : NULL; - arg2 = farg2->ptr ? static_cast< Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode > > * >(farg2->ptr) : &tempnull2; + smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::CrsGraph* >(smartarg1->get()) : NULL; + arg2 = farg2->cptr ? static_cast< Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode > > * >(farg2->cptr) : &tempnull2; SWIG_check_sp_nonnull(farg3, "Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::import_type *", "TpetraImport", "Tpetra::CrsGraph< LO,GO,NO >::importAndFillComplete(Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode > > &,Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::import_type const &,Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Teuchos::ParameterList > const &) const", return ) - smartarg3 = static_cast< Teuchos::RCP >* >(farg3->ptr); - arg3 = const_cast*>(smartarg3->get()); - arg4 = farg4->ptr ? static_cast< Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg4->ptr) : &tempnull4; - arg5 = farg5->ptr ? static_cast< Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg5->ptr) : &tempnull5; - arg6 = farg6->ptr ? static_cast< Teuchos::RCP< Teuchos::ParameterList > * >(farg6->ptr) : &tempnull6; + smartarg3 = static_cast< Teuchos::RCP >* >(farg3->cptr); + arg3 = const_cast< Tpetra::Import* >(smartarg3->get()); + arg4 = farg4->cptr ? static_cast< Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg4->cptr) : &tempnull4; + arg5 = farg5->cptr ? static_cast< Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg5->cptr) : &tempnull5; + arg6 = farg6->cptr ? static_cast< Teuchos::RCP< Teuchos::ParameterList > * >(farg6->cptr) : &tempnull6; { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::importAndFillComplete(Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode > > &,Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::import_type const &,Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Teuchos::ParameterList > const &) const");; @@ -9088,7 +9136,7 @@ SWIGEXPORT void _wrap_TpetraCrsGraph_importAndFillComplete__SWIG_0(SwigClassWrap SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::importAndFillComplete(Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode > > &,Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::import_type const &,Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Teuchos::ParameterList > const &) const", SWIG_UnknownError, "An unknown exception occurred", return ); } } - + } @@ -9104,14 +9152,14 @@ SWIGEXPORT void _wrap_TpetraCrsGraph_importAndFillComplete__SWIG_1(SwigClassWrap Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > tempnull4 ; Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > tempnull5 ; - smartarg1 = static_cast< Teuchos::RCP >* >(farg1->ptr); - arg1 = smartarg1 ? const_cast*>(smartarg1->get()) : NULL; - arg2 = farg2->ptr ? static_cast< Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode > > * >(farg2->ptr) : &tempnull2; + smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::CrsGraph* >(smartarg1->get()) : NULL; + arg2 = farg2->cptr ? static_cast< Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode > > * >(farg2->cptr) : &tempnull2; SWIG_check_sp_nonnull(farg3, "Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::import_type *", "TpetraImport", "Tpetra::CrsGraph< LO,GO,NO >::importAndFillComplete(Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode > > &,Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::import_type const &,Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &) const", return ) - smartarg3 = static_cast< Teuchos::RCP >* >(farg3->ptr); - arg3 = const_cast*>(smartarg3->get()); - arg4 = farg4->ptr ? static_cast< Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg4->ptr) : &tempnull4; - arg5 = farg5->ptr ? static_cast< Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg5->ptr) : &tempnull5; + smartarg3 = static_cast< Teuchos::RCP >* >(farg3->cptr); + arg3 = const_cast< Tpetra::Import* >(smartarg3->get()); + arg4 = farg4->cptr ? static_cast< Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg4->cptr) : &tempnull4; + arg5 = farg5->cptr ? static_cast< Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg5->cptr) : &tempnull5; { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::importAndFillComplete(Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode > > &,Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::import_type const &,Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &) const");; @@ -9135,7 +9183,7 @@ SWIGEXPORT void _wrap_TpetraCrsGraph_importAndFillComplete__SWIG_1(SwigClassWrap SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::importAndFillComplete(Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode > > &,Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::import_type const &,Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &) const", SWIG_UnknownError, "An unknown exception occurred", return ); } } - + } @@ -9155,18 +9203,18 @@ SWIGEXPORT void _wrap_TpetraCrsGraph_importAndFillComplete__SWIG_2(SwigClassWrap Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > tempnull6 ; Teuchos::RCP< Teuchos::ParameterList > tempnull7 ; - smartarg1 = static_cast< Teuchos::RCP >* >(farg1->ptr); - arg1 = smartarg1 ? const_cast*>(smartarg1->get()) : NULL; - arg2 = farg2->ptr ? static_cast< Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode > > * >(farg2->ptr) : &tempnull2; + smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::CrsGraph* >(smartarg1->get()) : NULL; + arg2 = farg2->cptr ? static_cast< Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode > > * >(farg2->cptr) : &tempnull2; SWIG_check_sp_nonnull(farg3, "Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::import_type *", "TpetraImport", "Tpetra::CrsGraph< LO,GO,NO >::importAndFillComplete(Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode > > &,Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::import_type const &,Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::import_type const &,Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Teuchos::ParameterList > const &) const", return ) - smartarg3 = static_cast< Teuchos::RCP >* >(farg3->ptr); - arg3 = const_cast*>(smartarg3->get()); + smartarg3 = static_cast< Teuchos::RCP >* >(farg3->cptr); + arg3 = const_cast< Tpetra::Import* >(smartarg3->get()); SWIG_check_sp_nonnull(farg4, "Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::import_type *", "TpetraImport", "Tpetra::CrsGraph< LO,GO,NO >::importAndFillComplete(Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode > > &,Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::import_type const &,Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::import_type const &,Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Teuchos::ParameterList > const &) const", return ) - smartarg4 = static_cast< Teuchos::RCP >* >(farg4->ptr); - arg4 = const_cast*>(smartarg4->get()); - arg5 = farg5->ptr ? static_cast< Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg5->ptr) : &tempnull5; - arg6 = farg6->ptr ? static_cast< Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg6->ptr) : &tempnull6; - arg7 = farg7->ptr ? static_cast< Teuchos::RCP< Teuchos::ParameterList > * >(farg7->ptr) : &tempnull7; + smartarg4 = static_cast< Teuchos::RCP >* >(farg4->cptr); + arg4 = const_cast< Tpetra::Import* >(smartarg4->get()); + arg5 = farg5->cptr ? static_cast< Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg5->cptr) : &tempnull5; + arg6 = farg6->cptr ? static_cast< Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg6->cptr) : &tempnull6; + arg7 = farg7->cptr ? static_cast< Teuchos::RCP< Teuchos::ParameterList > * >(farg7->cptr) : &tempnull7; { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::importAndFillComplete(Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode > > &,Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::import_type const &,Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::import_type const &,Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Teuchos::ParameterList > const &) const");; @@ -9208,15 +9256,15 @@ SWIGEXPORT void _wrap_TpetraCrsGraph_exportAndFillComplete__SWIG_0(SwigClassWrap Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > tempnull5 ; Teuchos::RCP< Teuchos::ParameterList > tempnull6 ; - smartarg1 = static_cast< Teuchos::RCP >* >(farg1->ptr); - arg1 = smartarg1 ? const_cast*>(smartarg1->get()) : NULL; - arg2 = farg2->ptr ? static_cast< Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode > > * >(farg2->ptr) : &tempnull2; + smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::CrsGraph* >(smartarg1->get()) : NULL; + arg2 = farg2->cptr ? static_cast< Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode > > * >(farg2->cptr) : &tempnull2; SWIG_check_sp_nonnull(farg3, "Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::export_type *", "TpetraExport", "Tpetra::CrsGraph< LO,GO,NO >::exportAndFillComplete(Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode > > &,Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::export_type const &,Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Teuchos::ParameterList > const &) const", return ) - smartarg3 = static_cast< Teuchos::RCP >* >(farg3->ptr); - arg3 = const_cast*>(smartarg3->get()); - arg4 = farg4->ptr ? static_cast< Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg4->ptr) : &tempnull4; - arg5 = farg5->ptr ? static_cast< Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg5->ptr) : &tempnull5; - arg6 = farg6->ptr ? static_cast< Teuchos::RCP< Teuchos::ParameterList > * >(farg6->ptr) : &tempnull6; + smartarg3 = static_cast< Teuchos::RCP >* >(farg3->cptr); + arg3 = const_cast< Tpetra::Export* >(smartarg3->get()); + arg4 = farg4->cptr ? static_cast< Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg4->cptr) : &tempnull4; + arg5 = farg5->cptr ? static_cast< Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg5->cptr) : &tempnull5; + arg6 = farg6->cptr ? static_cast< Teuchos::RCP< Teuchos::ParameterList > * >(farg6->cptr) : &tempnull6; { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::exportAndFillComplete(Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode > > &,Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::export_type const &,Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Teuchos::ParameterList > const &) const");; @@ -9256,14 +9304,14 @@ SWIGEXPORT void _wrap_TpetraCrsGraph_exportAndFillComplete__SWIG_1(SwigClassWrap Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > tempnull4 ; Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > tempnull5 ; - smartarg1 = static_cast< Teuchos::RCP >* >(farg1->ptr); - arg1 = smartarg1 ? const_cast*>(smartarg1->get()) : NULL; - arg2 = farg2->ptr ? static_cast< Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode > > * >(farg2->ptr) : &tempnull2; + smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::CrsGraph* >(smartarg1->get()) : NULL; + arg2 = farg2->cptr ? static_cast< Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode > > * >(farg2->cptr) : &tempnull2; SWIG_check_sp_nonnull(farg3, "Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::export_type *", "TpetraExport", "Tpetra::CrsGraph< LO,GO,NO >::exportAndFillComplete(Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode > > &,Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::export_type const &,Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &) const", return ) - smartarg3 = static_cast< Teuchos::RCP >* >(farg3->ptr); - arg3 = const_cast*>(smartarg3->get()); - arg4 = farg4->ptr ? static_cast< Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg4->ptr) : &tempnull4; - arg5 = farg5->ptr ? static_cast< Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg5->ptr) : &tempnull5; + smartarg3 = static_cast< Teuchos::RCP >* >(farg3->cptr); + arg3 = const_cast< Tpetra::Export* >(smartarg3->get()); + arg4 = farg4->cptr ? static_cast< Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg4->cptr) : &tempnull4; + arg5 = farg5->cptr ? static_cast< Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg5->cptr) : &tempnull5; { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::exportAndFillComplete(Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode > > &,Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::export_type const &,Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &) const");; @@ -9301,13 +9349,13 @@ SWIGEXPORT void _wrap_TpetraCrsGraph_exportAndFillComplete__SWIG_2(SwigClassWrap Teuchos::RCP< Tpetra::Export< LO,GO,NO > const > *smartarg3 ; Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > tempnull4 ; - smartarg1 = static_cast< Teuchos::RCP >* >(farg1->ptr); - arg1 = smartarg1 ? const_cast*>(smartarg1->get()) : NULL; - arg2 = farg2->ptr ? static_cast< Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode > > * >(farg2->ptr) : &tempnull2; + smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::CrsGraph* >(smartarg1->get()) : NULL; + arg2 = farg2->cptr ? static_cast< Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode > > * >(farg2->cptr) : &tempnull2; SWIG_check_sp_nonnull(farg3, "Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::export_type *", "TpetraExport", "Tpetra::CrsGraph< LO,GO,NO >::exportAndFillComplete(Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode > > &,Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::export_type const &,Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &) const", return ) - smartarg3 = static_cast< Teuchos::RCP >* >(farg3->ptr); - arg3 = const_cast*>(smartarg3->get()); - arg4 = farg4->ptr ? static_cast< Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg4->ptr) : &tempnull4; + smartarg3 = static_cast< Teuchos::RCP >* >(farg3->cptr); + arg3 = const_cast< Tpetra::Export* >(smartarg3->get()); + arg4 = farg4->cptr ? static_cast< Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg4->cptr) : &tempnull4; { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::exportAndFillComplete(Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode > > &,Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::export_type const &,Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &) const");; @@ -9343,12 +9391,12 @@ SWIGEXPORT void _wrap_TpetraCrsGraph_exportAndFillComplete__SWIG_3(SwigClassWrap Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode > > tempnull2 ; Teuchos::RCP< Tpetra::Export< LO,GO,NO > const > *smartarg3 ; - smartarg1 = static_cast< Teuchos::RCP >* >(farg1->ptr); - arg1 = smartarg1 ? const_cast*>(smartarg1->get()) : NULL; - arg2 = farg2->ptr ? static_cast< Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode > > * >(farg2->ptr) : &tempnull2; + smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::CrsGraph* >(smartarg1->get()) : NULL; + arg2 = farg2->cptr ? static_cast< Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode > > * >(farg2->cptr) : &tempnull2; SWIG_check_sp_nonnull(farg3, "Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::export_type *", "TpetraExport", "Tpetra::CrsGraph< LO,GO,NO >::exportAndFillComplete(Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode > > &,Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::export_type const &) const", return ) - smartarg3 = static_cast< Teuchos::RCP >* >(farg3->ptr); - arg3 = const_cast*>(smartarg3->get()); + smartarg3 = static_cast< Teuchos::RCP >* >(farg3->cptr); + arg3 = const_cast< Tpetra::Export* >(smartarg3->get()); { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::exportAndFillComplete(Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode > > &,Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::export_type const &) const");; @@ -9392,18 +9440,18 @@ SWIGEXPORT void _wrap_TpetraCrsGraph_exportAndFillComplete__SWIG_4(SwigClassWrap Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > tempnull6 ; Teuchos::RCP< Teuchos::ParameterList > tempnull7 ; - smartarg1 = static_cast< Teuchos::RCP >* >(farg1->ptr); - arg1 = smartarg1 ? const_cast*>(smartarg1->get()) : NULL; - arg2 = farg2->ptr ? static_cast< Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode > > * >(farg2->ptr) : &tempnull2; + smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::CrsGraph* >(smartarg1->get()) : NULL; + arg2 = farg2->cptr ? static_cast< Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode > > * >(farg2->cptr) : &tempnull2; SWIG_check_sp_nonnull(farg3, "Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::export_type *", "TpetraExport", "Tpetra::CrsGraph< LO,GO,NO >::exportAndFillComplete(Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode > > &,Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::export_type const &,Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::export_type const &,Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Teuchos::ParameterList > const &) const", return ) - smartarg3 = static_cast< Teuchos::RCP >* >(farg3->ptr); - arg3 = const_cast*>(smartarg3->get()); + smartarg3 = static_cast< Teuchos::RCP >* >(farg3->cptr); + arg3 = const_cast< Tpetra::Export* >(smartarg3->get()); SWIG_check_sp_nonnull(farg4, "Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::export_type *", "TpetraExport", "Tpetra::CrsGraph< LO,GO,NO >::exportAndFillComplete(Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode > > &,Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::export_type const &,Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::export_type const &,Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Teuchos::ParameterList > const &) const", return ) - smartarg4 = static_cast< Teuchos::RCP >* >(farg4->ptr); - arg4 = const_cast*>(smartarg4->get()); - arg5 = farg5->ptr ? static_cast< Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg5->ptr) : &tempnull5; - arg6 = farg6->ptr ? static_cast< Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg6->ptr) : &tempnull6; - arg7 = farg7->ptr ? static_cast< Teuchos::RCP< Teuchos::ParameterList > * >(farg7->ptr) : &tempnull7; + smartarg4 = static_cast< Teuchos::RCP >* >(farg4->cptr); + arg4 = const_cast< Tpetra::Export* >(smartarg4->get()); + arg5 = farg5->cptr ? static_cast< Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg5->cptr) : &tempnull5; + arg6 = farg6->cptr ? static_cast< Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg6->cptr) : &tempnull6; + arg7 = farg7->cptr ? static_cast< Teuchos::RCP< Teuchos::ParameterList > * >(farg7->cptr) : &tempnull7; { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::exportAndFillComplete(Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode > > &,Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::export_type const &,Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::export_type const &,Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Teuchos::ParameterList > const &) const");; @@ -9437,8 +9485,8 @@ SWIGEXPORT bool _wrap_TpetraCrsGraph_haveGlobalConstants(SwigClassWrapper const Teuchos::RCP< Tpetra::CrsGraph< LO,GO,NO > const > *smartarg1 ; bool result; - smartarg1 = static_cast< Teuchos::RCP >* >(farg1->ptr); - arg1 = smartarg1 ? const_cast*>(smartarg1->get()) : NULL; + smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::CrsGraph* >(smartarg1->get()) : NULL; { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::haveGlobalConstants() const");; @@ -9462,7 +9510,7 @@ SWIGEXPORT bool _wrap_TpetraCrsGraph_haveGlobalConstants(SwigClassWrapper const SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::haveGlobalConstants() const", SWIG_UnknownError, "An unknown exception occurred", return 0); } } - fresult = result; + fresult = static_cast< bool >(result); return fresult; } @@ -9472,9 +9520,9 @@ SWIGEXPORT void _wrap_TpetraCrsGraph_computeGlobalConstants(SwigClassWrapper con bool arg2 ; Teuchos::RCP< Tpetra::CrsGraph< LO,GO,NO > > *smartarg1 ; - smartarg1 = static_cast< Teuchos::RCP< Tpetra::CrsGraph >* >(farg1->ptr); - arg1 = smartarg1 ? smartarg1->get() : NULL; - arg2 = *farg2; + smartarg1 = static_cast< Teuchos::RCP< Tpetra::CrsGraph >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::CrsGraph* >(smartarg1->get()) : NULL; + arg2 = static_cast< bool >(*farg2); { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::computeGlobalConstants(bool const)");; @@ -9512,11 +9560,11 @@ SWIGEXPORT SwigClassWrapper _wrap_new_TpetraCrsGraph__SWIG_6(SwigClassWrapper co Teuchos::RCP< Teuchos::ParameterList > tempnull4 ; Tpetra::CrsGraph< LO,GO,NO > *result = 0 ; - arg1 = farg1->ptr ? static_cast< Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg1->ptr) : &tempnull1; + arg1 = farg1->cptr ? static_cast< Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg1->cptr) : &tempnull1; (&arg2)->first = static_cast(farg2->data); (&arg2)->second = farg2->size; arg3 = static_cast< Tpetra::ProfileType >(*farg3); - arg4 = farg4->ptr ? static_cast< Teuchos::RCP< Teuchos::ParameterList > * >(farg4->ptr) : &tempnull4; + arg4 = farg4->cptr ? static_cast< Teuchos::RCP< Teuchos::ParameterList > * >(farg4->cptr) : &tempnull4; { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::CrsGraph(Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,std::pair< std::size_t const *,std::size_t >,Tpetra::ProfileType const,Teuchos::RCP< Teuchos::ParameterList > const &)");; @@ -9540,7 +9588,7 @@ SWIGEXPORT SwigClassWrapper _wrap_new_TpetraCrsGraph__SWIG_6(SwigClassWrapper co SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::CrsGraph(Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,std::pair< std::size_t const *,std::size_t >,Tpetra::ProfileType const,Teuchos::RCP< Teuchos::ParameterList > const &)", SWIG_UnknownError, "An unknown exception occurred", return SwigClassWrapper_uninitialized()); } } - fresult.ptr = result ? new Teuchos::RCP< Tpetra::CrsGraph >(result SWIG_NO_NULL_DELETER_1) : NULL; + fresult.cptr = result ? new Teuchos::RCP< Tpetra::CrsGraph >(result SWIG_NO_NULL_DELETER_1) : NULL; fresult.mem = SWIG_MOVE; return fresult; } @@ -9554,7 +9602,7 @@ SWIGEXPORT SwigClassWrapper _wrap_new_TpetraCrsGraph__SWIG_7(SwigClassWrapper co Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > tempnull1 ; Tpetra::CrsGraph< LO,GO,NO > *result = 0 ; - arg1 = farg1->ptr ? static_cast< Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg1->ptr) : &tempnull1; + arg1 = farg1->cptr ? static_cast< Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg1->cptr) : &tempnull1; (&arg2)->first = static_cast(farg2->data); (&arg2)->second = farg2->size; arg3 = static_cast< Tpetra::ProfileType >(*farg3); @@ -9581,7 +9629,7 @@ SWIGEXPORT SwigClassWrapper _wrap_new_TpetraCrsGraph__SWIG_7(SwigClassWrapper co SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::CrsGraph(Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,std::pair< std::size_t const *,std::size_t >,Tpetra::ProfileType const)", SWIG_UnknownError, "An unknown exception occurred", return SwigClassWrapper_uninitialized()); } } - fresult.ptr = result ? new Teuchos::RCP< Tpetra::CrsGraph >(result SWIG_NO_NULL_DELETER_1) : NULL; + fresult.cptr = result ? new Teuchos::RCP< Tpetra::CrsGraph >(result SWIG_NO_NULL_DELETER_1) : NULL; fresult.mem = SWIG_MOVE; return fresult; } @@ -9594,7 +9642,7 @@ SWIGEXPORT SwigClassWrapper _wrap_new_TpetraCrsGraph__SWIG_8(SwigClassWrapper co Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > tempnull1 ; Tpetra::CrsGraph< LO,GO,NO > *result = 0 ; - arg1 = farg1->ptr ? static_cast< Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg1->ptr) : &tempnull1; + arg1 = farg1->cptr ? static_cast< Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg1->cptr) : &tempnull1; (&arg2)->first = static_cast(farg2->data); (&arg2)->second = farg2->size; { @@ -9620,7 +9668,7 @@ SWIGEXPORT SwigClassWrapper _wrap_new_TpetraCrsGraph__SWIG_8(SwigClassWrapper co SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::CrsGraph(Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,std::pair< std::size_t const *,std::size_t >)", SWIG_UnknownError, "An unknown exception occurred", return SwigClassWrapper_uninitialized()); } } - fresult.ptr = result ? new Teuchos::RCP< Tpetra::CrsGraph >(result SWIG_NO_NULL_DELETER_1) : NULL; + fresult.cptr = result ? new Teuchos::RCP< Tpetra::CrsGraph >(result SWIG_NO_NULL_DELETER_1) : NULL; fresult.mem = SWIG_MOVE; return fresult; } @@ -9638,12 +9686,12 @@ SWIGEXPORT SwigClassWrapper _wrap_new_TpetraCrsGraph__SWIG_9(SwigClassWrapper co Teuchos::RCP< Teuchos::ParameterList > tempnull5 ; Tpetra::CrsGraph< LO,GO,NO > *result = 0 ; - arg1 = farg1->ptr ? static_cast< Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg1->ptr) : &tempnull1; - arg2 = farg2->ptr ? static_cast< Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg2->ptr) : &tempnull2; + arg1 = farg1->cptr ? static_cast< Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg1->cptr) : &tempnull1; + arg2 = farg2->cptr ? static_cast< Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg2->cptr) : &tempnull2; (&arg3)->first = static_cast(farg3->data); (&arg3)->second = farg3->size; arg4 = static_cast< Tpetra::ProfileType >(*farg4); - arg5 = farg5->ptr ? static_cast< Teuchos::RCP< Teuchos::ParameterList > * >(farg5->ptr) : &tempnull5; + arg5 = farg5->cptr ? static_cast< Teuchos::RCP< Teuchos::ParameterList > * >(farg5->cptr) : &tempnull5; { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::CrsGraph(Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,std::pair< std::size_t const *,std::size_t >,Tpetra::ProfileType const,Teuchos::RCP< Teuchos::ParameterList > const &)");; @@ -9667,7 +9715,7 @@ SWIGEXPORT SwigClassWrapper _wrap_new_TpetraCrsGraph__SWIG_9(SwigClassWrapper co SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::CrsGraph(Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,std::pair< std::size_t const *,std::size_t >,Tpetra::ProfileType const,Teuchos::RCP< Teuchos::ParameterList > const &)", SWIG_UnknownError, "An unknown exception occurred", return SwigClassWrapper_uninitialized()); } } - fresult.ptr = result ? new Teuchos::RCP< Tpetra::CrsGraph >(result SWIG_NO_NULL_DELETER_1) : NULL; + fresult.cptr = result ? new Teuchos::RCP< Tpetra::CrsGraph >(result SWIG_NO_NULL_DELETER_1) : NULL; fresult.mem = SWIG_MOVE; return fresult; } @@ -9683,8 +9731,8 @@ SWIGEXPORT SwigClassWrapper _wrap_new_TpetraCrsGraph__SWIG_10(SwigClassWrapper c Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > tempnull2 ; Tpetra::CrsGraph< LO,GO,NO > *result = 0 ; - arg1 = farg1->ptr ? static_cast< Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg1->ptr) : &tempnull1; - arg2 = farg2->ptr ? static_cast< Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg2->ptr) : &tempnull2; + arg1 = farg1->cptr ? static_cast< Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg1->cptr) : &tempnull1; + arg2 = farg2->cptr ? static_cast< Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg2->cptr) : &tempnull2; (&arg3)->first = static_cast(farg3->data); (&arg3)->second = farg3->size; arg4 = static_cast< Tpetra::ProfileType >(*farg4); @@ -9711,7 +9759,7 @@ SWIGEXPORT SwigClassWrapper _wrap_new_TpetraCrsGraph__SWIG_10(SwigClassWrapper c SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::CrsGraph(Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,std::pair< std::size_t const *,std::size_t >,Tpetra::ProfileType const)", SWIG_UnknownError, "An unknown exception occurred", return SwigClassWrapper_uninitialized()); } } - fresult.ptr = result ? new Teuchos::RCP< Tpetra::CrsGraph >(result SWIG_NO_NULL_DELETER_1) : NULL; + fresult.cptr = result ? new Teuchos::RCP< Tpetra::CrsGraph >(result SWIG_NO_NULL_DELETER_1) : NULL; fresult.mem = SWIG_MOVE; return fresult; } @@ -9726,8 +9774,8 @@ SWIGEXPORT SwigClassWrapper _wrap_new_TpetraCrsGraph__SWIG_11(SwigClassWrapper c Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > tempnull2 ; Tpetra::CrsGraph< LO,GO,NO > *result = 0 ; - arg1 = farg1->ptr ? static_cast< Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg1->ptr) : &tempnull1; - arg2 = farg2->ptr ? static_cast< Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg2->ptr) : &tempnull2; + arg1 = farg1->cptr ? static_cast< Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg1->cptr) : &tempnull1; + arg2 = farg2->cptr ? static_cast< Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg2->cptr) : &tempnull2; (&arg3)->first = static_cast(farg3->data); (&arg3)->second = farg3->size; { @@ -9753,7 +9801,7 @@ SWIGEXPORT SwigClassWrapper _wrap_new_TpetraCrsGraph__SWIG_11(SwigClassWrapper c SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::CrsGraph(Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,std::pair< std::size_t const *,std::size_t >)", SWIG_UnknownError, "An unknown exception occurred", return SwigClassWrapper_uninitialized()); } } - fresult.ptr = result ? new Teuchos::RCP< Tpetra::CrsGraph >(result SWIG_NO_NULL_DELETER_1) : NULL; + fresult.cptr = result ? new Teuchos::RCP< Tpetra::CrsGraph >(result SWIG_NO_NULL_DELETER_1) : NULL; fresult.mem = SWIG_MOVE; return fresult; } @@ -9771,13 +9819,13 @@ SWIGEXPORT SwigClassWrapper _wrap_new_TpetraCrsGraph__SWIG_12(SwigClassWrapper c Teuchos::RCP< Teuchos::ParameterList > tempnull5 ; Tpetra::CrsGraph< LO,GO,NO > *result = 0 ; - arg1 = farg1->ptr ? static_cast< Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg1->ptr) : &tempnull1; - arg2 = farg2->ptr ? static_cast< Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg2->ptr) : &tempnull2; + arg1 = farg1->cptr ? static_cast< Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg1->cptr) : &tempnull1; + arg2 = farg2->cptr ? static_cast< Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg2->cptr) : &tempnull2; (&arg3)->first = static_cast(farg3->data); (&arg3)->second = farg3->size; (&arg4)->first = static_cast(farg4->data); (&arg4)->second = farg4->size; - arg5 = farg5->ptr ? static_cast< Teuchos::RCP< Teuchos::ParameterList > * >(farg5->ptr) : &tempnull5; + arg5 = farg5->cptr ? static_cast< Teuchos::RCP< Teuchos::ParameterList > * >(farg5->cptr) : &tempnull5; { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::CrsGraph(Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,std::pair< std::size_t *,std::size_t >,std::pair< LO *,std::size_t >,Teuchos::RCP< Teuchos::ParameterList > const &)");; @@ -9801,7 +9849,7 @@ SWIGEXPORT SwigClassWrapper _wrap_new_TpetraCrsGraph__SWIG_12(SwigClassWrapper c SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::CrsGraph(Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,std::pair< std::size_t *,std::size_t >,std::pair< LO *,std::size_t >,Teuchos::RCP< Teuchos::ParameterList > const &)", SWIG_UnknownError, "An unknown exception occurred", return SwigClassWrapper_uninitialized()); } } - fresult.ptr = result ? new Teuchos::RCP< Tpetra::CrsGraph >(result SWIG_NO_NULL_DELETER_1) : NULL; + fresult.cptr = result ? new Teuchos::RCP< Tpetra::CrsGraph >(result SWIG_NO_NULL_DELETER_1) : NULL; fresult.mem = SWIG_MOVE; return fresult; } @@ -9817,8 +9865,8 @@ SWIGEXPORT SwigClassWrapper _wrap_new_TpetraCrsGraph__SWIG_13(SwigClassWrapper c Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > tempnull2 ; Tpetra::CrsGraph< LO,GO,NO > *result = 0 ; - arg1 = farg1->ptr ? static_cast< Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg1->ptr) : &tempnull1; - arg2 = farg2->ptr ? static_cast< Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg2->ptr) : &tempnull2; + arg1 = farg1->cptr ? static_cast< Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg1->cptr) : &tempnull1; + arg2 = farg2->cptr ? static_cast< Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg2->cptr) : &tempnull2; (&arg3)->first = static_cast(farg3->data); (&arg3)->second = farg3->size; (&arg4)->first = static_cast(farg4->data); @@ -9846,7 +9894,7 @@ SWIGEXPORT SwigClassWrapper _wrap_new_TpetraCrsGraph__SWIG_13(SwigClassWrapper c SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::CrsGraph(Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,std::pair< std::size_t *,std::size_t >,std::pair< LO *,std::size_t >)", SWIG_UnknownError, "An unknown exception occurred", return SwigClassWrapper_uninitialized()); } } - fresult.ptr = result ? new Teuchos::RCP< Tpetra::CrsGraph >(result SWIG_NO_NULL_DELETER_1) : NULL; + fresult.cptr = result ? new Teuchos::RCP< Tpetra::CrsGraph >(result SWIG_NO_NULL_DELETER_1) : NULL; fresult.mem = SWIG_MOVE; return fresult; } @@ -9858,9 +9906,9 @@ SWIGEXPORT void _wrap_TpetraCrsGraph_insertGlobalIndices__SWIG_1(SwigClassWrappe std::pair< GO const *,std::size_t > arg3 ; Teuchos::RCP< Tpetra::CrsGraph< LO,GO,NO > > *smartarg1 ; - smartarg1 = static_cast< Teuchos::RCP< Tpetra::CrsGraph >* >(farg1->ptr); - arg1 = smartarg1 ? smartarg1->get() : NULL; - arg2 = *farg2; + smartarg1 = static_cast< Teuchos::RCP< Tpetra::CrsGraph >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::CrsGraph* >(smartarg1->get()) : NULL; + arg2 = static_cast< GO >(*farg2); (&arg3)->first = static_cast(farg3->data); (&arg3)->second = farg3->size; { @@ -9896,8 +9944,8 @@ SWIGEXPORT void _wrap_TpetraCrsGraph_insertLocalIndices(SwigClassWrapper const * std::pair< LO const *,std::size_t > arg3 ; Teuchos::RCP< Tpetra::CrsGraph< LO,GO,NO > > *smartarg1 ; - smartarg1 = static_cast< Teuchos::RCP< Tpetra::CrsGraph >* >(farg1->ptr); - arg1 = smartarg1 ? smartarg1->get() : NULL; + smartarg1 = static_cast< Teuchos::RCP< Tpetra::CrsGraph >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::CrsGraph* >(smartarg1->get()) : NULL; arg2 = *farg2 - 1; (&arg3)->first = static_cast(farg3->data); (&arg3)->second = farg3->size; @@ -9935,9 +9983,9 @@ SWIGEXPORT void _wrap_TpetraCrsGraph_getGlobalRowCopy(SwigClassWrapper const *fa size_t *arg4 = 0 ; Teuchos::RCP< Tpetra::CrsGraph< LO,GO,NO > const > *smartarg1 ; - smartarg1 = static_cast< Teuchos::RCP >* >(farg1->ptr); - arg1 = smartarg1 ? const_cast*>(smartarg1->get()) : NULL; - arg2 = *farg2; + smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::CrsGraph* >(smartarg1->get()) : NULL; + arg2 = static_cast< GO >(*farg2); (&arg3)->first = static_cast(farg3->data); (&arg3)->second = farg3->size; arg4 = reinterpret_cast< size_t * >(farg4); @@ -9975,8 +10023,8 @@ SWIGEXPORT void _wrap_TpetraCrsGraph_getLocalRowCopy(SwigClassWrapper const *far size_t *arg4 = 0 ; Teuchos::RCP< Tpetra::CrsGraph< LO,GO,NO > const > *smartarg1 ; - smartarg1 = static_cast< Teuchos::RCP >* >(farg1->ptr); - arg1 = smartarg1 ? const_cast*>(smartarg1->get()) : NULL; + smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::CrsGraph* >(smartarg1->get()) : NULL; arg2 = *farg2 - 1; (&arg3)->first = static_cast(farg3->data); (&arg3)->second = farg3->size; @@ -10014,9 +10062,9 @@ SWIGEXPORT void _wrap_TpetraCrsGraph_getgblRowView(SwigClassWrapper const *farg1 std::pair< GO const *,std::size_t > arg3 ; Teuchos::RCP< Tpetra::CrsGraph< LO,GO,NO > const > *smartarg1 ; - smartarg1 = static_cast< Teuchos::RCP >* >(farg1->ptr); - arg1 = smartarg1 ? const_cast*>(smartarg1->get()) : NULL; - arg2 = *farg2; + smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::CrsGraph* >(smartarg1->get()) : NULL; + arg2 = static_cast< GO >(*farg2); (&arg3)->first = static_cast(farg3->data); (&arg3)->second = farg3->size; { @@ -10053,8 +10101,8 @@ SWIGEXPORT void _wrap_TpetraCrsGraph_setAllIndices(SwigClassWrapper const *farg1 std::pair< SC *,std::size_t > arg4 ; Teuchos::RCP< Tpetra::CrsGraph< LO,GO,NO > > *smartarg1 ; - smartarg1 = static_cast< Teuchos::RCP< Tpetra::CrsGraph >* >(farg1->ptr); - arg1 = smartarg1 ? smartarg1->get() : NULL; + smartarg1 = static_cast< Teuchos::RCP< Tpetra::CrsGraph >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::CrsGraph* >(smartarg1->get()) : NULL; (&arg2)->first = static_cast(farg2->data); (&arg2)->second = farg2->size; (&arg3)->first = static_cast(farg3->data); @@ -10093,8 +10141,8 @@ SWIGEXPORT void _wrap_TpetraCrsGraph_getNodeRowPtrs(SwigClassWrapper const *farg std::pair< std::size_t *,std::size_t > arg2 ; Teuchos::RCP< Tpetra::CrsGraph< LO,GO,NO > const > *smartarg1 ; - smartarg1 = static_cast< Teuchos::RCP >* >(farg1->ptr); - arg1 = smartarg1 ? const_cast*>(smartarg1->get()) : NULL; + smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::CrsGraph* >(smartarg1->get()) : NULL; (&arg2)->first = static_cast(farg2->data); (&arg2)->second = farg2->size; { @@ -10129,8 +10177,8 @@ SWIGEXPORT void _wrap_TpetraCrsGraph_getNodePackedIndices(SwigClassWrapper const std::pair< std::size_t *,std::size_t > arg2 ; Teuchos::RCP< Tpetra::CrsGraph< LO,GO,NO > const > *smartarg1 ; - smartarg1 = static_cast< Teuchos::RCP >* >(farg1->ptr); - arg1 = smartarg1 ? const_cast*>(smartarg1->get()) : NULL; + smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::CrsGraph* >(smartarg1->get()) : NULL; (&arg2)->first = static_cast(farg2->data); (&arg2)->second = farg2->size; { @@ -10165,8 +10213,8 @@ SWIGEXPORT void _wrap_TpetraCrsGraph_getLocalDiagOffsets(SwigClassWrapper const std::pair< std::size_t *,std::size_t > arg2 ; Teuchos::RCP< Tpetra::CrsGraph< LO,GO,NO > const > *smartarg1 ; - smartarg1 = static_cast< Teuchos::RCP >* >(farg1->ptr); - arg1 = smartarg1 ? const_cast*>(smartarg1->get()) : NULL; + smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::CrsGraph* >(smartarg1->get()) : NULL; (&arg2)->first = static_cast(farg2->data); (&arg2)->second = farg2->size; { @@ -10205,14 +10253,14 @@ SWIGEXPORT void _wrap_TpetraCrsGraph_doImport__SWIG_0(SwigClassWrapper const *fa Teuchos::RCP< Tpetra::CrsGraph< LO,GO,NO > const > *smartarg2 ; Teuchos::RCP< Tpetra::Import< LO,GO,NO > const > *smartarg3 ; - smartarg1 = static_cast< Teuchos::RCP< Tpetra::CrsGraph >* >(farg1->ptr); - arg1 = smartarg1 ? smartarg1->get() : NULL; + smartarg1 = static_cast< Teuchos::RCP< Tpetra::CrsGraph >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::CrsGraph* >(smartarg1->get()) : NULL; SWIG_check_sp_nonnull(farg2, "Tpetra::CrsGraph< LO,GO,NO > *", "TpetraCrsGraph", "Tpetra::CrsGraph< LO,GO,NO >::doImport(Tpetra::CrsGraph< LO,GO,NO > const &,Tpetra::Import< LO,GO,NO > const &,Tpetra::CombineMode)", return ) - smartarg2 = static_cast< Teuchos::RCP >* >(farg2->ptr); - arg2 = const_cast*>(smartarg2->get()); + smartarg2 = static_cast< Teuchos::RCP >* >(farg2->cptr); + arg2 = const_cast< Tpetra::CrsGraph* >(smartarg2->get()); SWIG_check_sp_nonnull(farg3, "Tpetra::Import< LO,GO,NO > *", "TpetraImport", "Tpetra::CrsGraph< LO,GO,NO >::doImport(Tpetra::CrsGraph< LO,GO,NO > const &,Tpetra::Import< LO,GO,NO > const &,Tpetra::CombineMode)", return ) - smartarg3 = static_cast< Teuchos::RCP >* >(farg3->ptr); - arg3 = const_cast*>(smartarg3->get()); + smartarg3 = static_cast< Teuchos::RCP >* >(farg3->cptr); + arg3 = const_cast< Tpetra::Import* >(smartarg3->get()); arg4 = static_cast< Tpetra::CombineMode >(*farg4); { // Make sure no unhandled exceptions exist before performing a new action @@ -10250,14 +10298,14 @@ SWIGEXPORT void _wrap_TpetraCrsGraph_doImport__SWIG_1(SwigClassWrapper const *fa Teuchos::RCP< Tpetra::CrsGraph< LO,GO,NO > const > *smartarg2 ; Teuchos::RCP< Tpetra::Export< LO,GO,NO > const > *smartarg3 ; - smartarg1 = static_cast< Teuchos::RCP< Tpetra::CrsGraph >* >(farg1->ptr); - arg1 = smartarg1 ? smartarg1->get() : NULL; + smartarg1 = static_cast< Teuchos::RCP< Tpetra::CrsGraph >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::CrsGraph* >(smartarg1->get()) : NULL; SWIG_check_sp_nonnull(farg2, "Tpetra::CrsGraph< LO,GO,NO > *", "TpetraCrsGraph", "Tpetra::CrsGraph< LO,GO,NO >::doImport(Tpetra::CrsGraph< LO,GO,NO > const &,Tpetra::Export< LO,GO,NO > const &,Tpetra::CombineMode)", return ) - smartarg2 = static_cast< Teuchos::RCP >* >(farg2->ptr); - arg2 = const_cast*>(smartarg2->get()); + smartarg2 = static_cast< Teuchos::RCP >* >(farg2->cptr); + arg2 = const_cast< Tpetra::CrsGraph* >(smartarg2->get()); SWIG_check_sp_nonnull(farg3, "Tpetra::Export< LO,GO,NO > *", "TpetraExport", "Tpetra::CrsGraph< LO,GO,NO >::doImport(Tpetra::CrsGraph< LO,GO,NO > const &,Tpetra::Export< LO,GO,NO > const &,Tpetra::CombineMode)", return ) - smartarg3 = static_cast< Teuchos::RCP >* >(farg3->ptr); - arg3 = const_cast*>(smartarg3->get()); + smartarg3 = static_cast< Teuchos::RCP >* >(farg3->cptr); + arg3 = const_cast< Tpetra::Export* >(smartarg3->get()); arg4 = static_cast< Tpetra::CombineMode >(*farg4); { // Make sure no unhandled exceptions exist before performing a new action @@ -10295,14 +10343,14 @@ SWIGEXPORT void _wrap_TpetraCrsGraph_doExport__SWIG_0(SwigClassWrapper const *fa Teuchos::RCP< Tpetra::CrsGraph< LO,GO,NO > const > *smartarg2 ; Teuchos::RCP< Tpetra::Export< LO,GO,NO > const > *smartarg3 ; - smartarg1 = static_cast< Teuchos::RCP< Tpetra::CrsGraph >* >(farg1->ptr); - arg1 = smartarg1 ? smartarg1->get() : NULL; + smartarg1 = static_cast< Teuchos::RCP< Tpetra::CrsGraph >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::CrsGraph* >(smartarg1->get()) : NULL; SWIG_check_sp_nonnull(farg2, "Tpetra::CrsGraph< LO,GO,NO > *", "TpetraCrsGraph", "Tpetra::CrsGraph< LO,GO,NO >::doExport(Tpetra::CrsGraph< LO,GO,NO > const &,Tpetra::Export< LO,GO,NO > const &,Tpetra::CombineMode)", return ) - smartarg2 = static_cast< Teuchos::RCP >* >(farg2->ptr); - arg2 = const_cast*>(smartarg2->get()); + smartarg2 = static_cast< Teuchos::RCP >* >(farg2->cptr); + arg2 = const_cast< Tpetra::CrsGraph* >(smartarg2->get()); SWIG_check_sp_nonnull(farg3, "Tpetra::Export< LO,GO,NO > *", "TpetraExport", "Tpetra::CrsGraph< LO,GO,NO >::doExport(Tpetra::CrsGraph< LO,GO,NO > const &,Tpetra::Export< LO,GO,NO > const &,Tpetra::CombineMode)", return ) - smartarg3 = static_cast< Teuchos::RCP >* >(farg3->ptr); - arg3 = const_cast*>(smartarg3->get()); + smartarg3 = static_cast< Teuchos::RCP >* >(farg3->cptr); + arg3 = const_cast< Tpetra::Export* >(smartarg3->get()); arg4 = static_cast< Tpetra::CombineMode >(*farg4); { // Make sure no unhandled exceptions exist before performing a new action @@ -10340,14 +10388,14 @@ SWIGEXPORT void _wrap_TpetraCrsGraph_doExport__SWIG_1(SwigClassWrapper const *fa Teuchos::RCP< Tpetra::CrsGraph< LO,GO,NO > const > *smartarg2 ; Teuchos::RCP< Tpetra::Import< LO,GO,NO > const > *smartarg3 ; - smartarg1 = static_cast< Teuchos::RCP< Tpetra::CrsGraph >* >(farg1->ptr); - arg1 = smartarg1 ? smartarg1->get() : NULL; + smartarg1 = static_cast< Teuchos::RCP< Tpetra::CrsGraph >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::CrsGraph* >(smartarg1->get()) : NULL; SWIG_check_sp_nonnull(farg2, "Tpetra::CrsGraph< LO,GO,NO > *", "TpetraCrsGraph", "Tpetra::CrsGraph< LO,GO,NO >::doExport(Tpetra::CrsGraph< LO,GO,NO > const &,Tpetra::Import< LO,GO,NO > const &,Tpetra::CombineMode)", return ) - smartarg2 = static_cast< Teuchos::RCP >* >(farg2->ptr); - arg2 = const_cast*>(smartarg2->get()); + smartarg2 = static_cast< Teuchos::RCP >* >(farg2->cptr); + arg2 = const_cast< Tpetra::CrsGraph* >(smartarg2->get()); SWIG_check_sp_nonnull(farg3, "Tpetra::Import< LO,GO,NO > *", "TpetraImport", "Tpetra::CrsGraph< LO,GO,NO >::doExport(Tpetra::CrsGraph< LO,GO,NO > const &,Tpetra::Import< LO,GO,NO > const &,Tpetra::CombineMode)", return ) - smartarg3 = static_cast< Teuchos::RCP >* >(farg3->ptr); - arg3 = const_cast*>(smartarg3->get()); + smartarg3 = static_cast< Teuchos::RCP >* >(farg3->cptr); + arg3 = const_cast< Tpetra::Import* >(smartarg3->get()); arg4 = static_cast< Tpetra::CombineMode >(*farg4); { // Make sure no unhandled exceptions exist before performing a new action @@ -10377,7 +10425,7 @@ SWIGEXPORT void _wrap_TpetraCrsGraph_doExport__SWIG_1(SwigClassWrapper const *fa SWIGEXPORT void _wrap_assign_TpetraCrsGraph(SwigClassWrapper * self, SwigClassWrapper const * other) { - typedef ::Teuchos::RCP< Tpetra::CrsGraph > swig_lhs_classtype; + typedef Teuchos::RCP< Tpetra::CrsGraph > swig_lhs_classtype; SWIG_assign(swig_lhs_classtype, self, swig_lhs_classtype, const_cast(other), 0 | swig::IS_DESTR | swig::IS_COPY_CONSTR); @@ -10394,10 +10442,10 @@ SWIGEXPORT SwigClassWrapper _wrap_new_TpetraCrsMatrix__SWIG_0(SwigClassWrapper c Teuchos::RCP< Teuchos::ParameterList > tempnull4 ; Tpetra::CrsMatrix< SC,LO,GO,NO > *result = 0 ; - arg1 = farg1->ptr ? static_cast< Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg1->ptr) : &tempnull1; - arg2 = *farg2; + arg1 = farg1->cptr ? static_cast< Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg1->cptr) : &tempnull1; + arg2 = static_cast< size_t >(*farg2); arg3 = static_cast< Tpetra::ProfileType >(*farg3); - arg4 = farg4->ptr ? static_cast< Teuchos::RCP< Teuchos::ParameterList > * >(farg4->ptr) : &tempnull4; + arg4 = farg4->cptr ? static_cast< Teuchos::RCP< Teuchos::ParameterList > * >(farg4->cptr) : &tempnull4; { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::CrsMatrix(Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,size_t,Tpetra::ProfileType,Teuchos::RCP< Teuchos::ParameterList > const &)");; @@ -10421,7 +10469,7 @@ SWIGEXPORT SwigClassWrapper _wrap_new_TpetraCrsMatrix__SWIG_0(SwigClassWrapper c SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::CrsMatrix(Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,size_t,Tpetra::ProfileType,Teuchos::RCP< Teuchos::ParameterList > const &)", SWIG_UnknownError, "An unknown exception occurred", return SwigClassWrapper_uninitialized()); } } - fresult.ptr = result ? new Teuchos::RCP< Tpetra::CrsMatrix >(result SWIG_NO_NULL_DELETER_1) : NULL; + fresult.cptr = result ? new Teuchos::RCP< Tpetra::CrsMatrix >(result SWIG_NO_NULL_DELETER_1) : NULL; fresult.mem = SWIG_MOVE; return fresult; } @@ -10435,8 +10483,8 @@ SWIGEXPORT SwigClassWrapper _wrap_new_TpetraCrsMatrix__SWIG_1(SwigClassWrapper c Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > tempnull1 ; Tpetra::CrsMatrix< SC,LO,GO,NO > *result = 0 ; - arg1 = farg1->ptr ? static_cast< Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg1->ptr) : &tempnull1; - arg2 = *farg2; + arg1 = farg1->cptr ? static_cast< Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg1->cptr) : &tempnull1; + arg2 = static_cast< size_t >(*farg2); arg3 = static_cast< Tpetra::ProfileType >(*farg3); { // Make sure no unhandled exceptions exist before performing a new action @@ -10461,7 +10509,7 @@ SWIGEXPORT SwigClassWrapper _wrap_new_TpetraCrsMatrix__SWIG_1(SwigClassWrapper c SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::CrsMatrix(Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,size_t,Tpetra::ProfileType)", SWIG_UnknownError, "An unknown exception occurred", return SwigClassWrapper_uninitialized()); } } - fresult.ptr = result ? new Teuchos::RCP< Tpetra::CrsMatrix >(result SWIG_NO_NULL_DELETER_1) : NULL; + fresult.cptr = result ? new Teuchos::RCP< Tpetra::CrsMatrix >(result SWIG_NO_NULL_DELETER_1) : NULL; fresult.mem = SWIG_MOVE; return fresult; } @@ -10474,8 +10522,8 @@ SWIGEXPORT SwigClassWrapper _wrap_new_TpetraCrsMatrix__SWIG_2(SwigClassWrapper c Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > tempnull1 ; Tpetra::CrsMatrix< SC,LO,GO,NO > *result = 0 ; - arg1 = farg1->ptr ? static_cast< Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg1->ptr) : &tempnull1; - arg2 = *farg2; + arg1 = farg1->cptr ? static_cast< Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg1->cptr) : &tempnull1; + arg2 = static_cast< size_t >(*farg2); { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::CrsMatrix(Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,size_t)");; @@ -10499,7 +10547,7 @@ SWIGEXPORT SwigClassWrapper _wrap_new_TpetraCrsMatrix__SWIG_2(SwigClassWrapper c SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::CrsMatrix(Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,size_t)", SWIG_UnknownError, "An unknown exception occurred", return SwigClassWrapper_uninitialized()); } } - fresult.ptr = result ? new Teuchos::RCP< Tpetra::CrsMatrix >(result SWIG_NO_NULL_DELETER_1) : NULL; + fresult.cptr = result ? new Teuchos::RCP< Tpetra::CrsMatrix >(result SWIG_NO_NULL_DELETER_1) : NULL; fresult.mem = SWIG_MOVE; return fresult; } @@ -10517,11 +10565,11 @@ SWIGEXPORT SwigClassWrapper _wrap_new_TpetraCrsMatrix__SWIG_3(SwigClassWrapper c Teuchos::RCP< Teuchos::ParameterList > tempnull5 ; Tpetra::CrsMatrix< SC,LO,GO,NO > *result = 0 ; - arg1 = farg1->ptr ? static_cast< Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg1->ptr) : &tempnull1; - arg2 = farg2->ptr ? static_cast< Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg2->ptr) : &tempnull2; - arg3 = *farg3; + arg1 = farg1->cptr ? static_cast< Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg1->cptr) : &tempnull1; + arg2 = farg2->cptr ? static_cast< Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg2->cptr) : &tempnull2; + arg3 = static_cast< size_t >(*farg3); arg4 = static_cast< Tpetra::ProfileType >(*farg4); - arg5 = farg5->ptr ? static_cast< Teuchos::RCP< Teuchos::ParameterList > * >(farg5->ptr) : &tempnull5; + arg5 = farg5->cptr ? static_cast< Teuchos::RCP< Teuchos::ParameterList > * >(farg5->cptr) : &tempnull5; { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::CrsMatrix(Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,size_t,Tpetra::ProfileType,Teuchos::RCP< Teuchos::ParameterList > const &)");; @@ -10545,7 +10593,7 @@ SWIGEXPORT SwigClassWrapper _wrap_new_TpetraCrsMatrix__SWIG_3(SwigClassWrapper c SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::CrsMatrix(Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,size_t,Tpetra::ProfileType,Teuchos::RCP< Teuchos::ParameterList > const &)", SWIG_UnknownError, "An unknown exception occurred", return SwigClassWrapper_uninitialized()); } } - fresult.ptr = result ? new Teuchos::RCP< Tpetra::CrsMatrix >(result SWIG_NO_NULL_DELETER_1) : NULL; + fresult.cptr = result ? new Teuchos::RCP< Tpetra::CrsMatrix >(result SWIG_NO_NULL_DELETER_1) : NULL; fresult.mem = SWIG_MOVE; return fresult; } @@ -10561,9 +10609,9 @@ SWIGEXPORT SwigClassWrapper _wrap_new_TpetraCrsMatrix__SWIG_4(SwigClassWrapper c Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > tempnull2 ; Tpetra::CrsMatrix< SC,LO,GO,NO > *result = 0 ; - arg1 = farg1->ptr ? static_cast< Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg1->ptr) : &tempnull1; - arg2 = farg2->ptr ? static_cast< Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg2->ptr) : &tempnull2; - arg3 = *farg3; + arg1 = farg1->cptr ? static_cast< Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg1->cptr) : &tempnull1; + arg2 = farg2->cptr ? static_cast< Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg2->cptr) : &tempnull2; + arg3 = static_cast< size_t >(*farg3); arg4 = static_cast< Tpetra::ProfileType >(*farg4); { // Make sure no unhandled exceptions exist before performing a new action @@ -10588,7 +10636,7 @@ SWIGEXPORT SwigClassWrapper _wrap_new_TpetraCrsMatrix__SWIG_4(SwigClassWrapper c SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::CrsMatrix(Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,size_t,Tpetra::ProfileType)", SWIG_UnknownError, "An unknown exception occurred", return SwigClassWrapper_uninitialized()); } } - fresult.ptr = result ? new Teuchos::RCP< Tpetra::CrsMatrix >(result SWIG_NO_NULL_DELETER_1) : NULL; + fresult.cptr = result ? new Teuchos::RCP< Tpetra::CrsMatrix >(result SWIG_NO_NULL_DELETER_1) : NULL; fresult.mem = SWIG_MOVE; return fresult; } @@ -10602,10 +10650,10 @@ SWIGEXPORT SwigClassWrapper _wrap_new_TpetraCrsMatrix__SWIG_5(SwigClassWrapper c Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > tempnull1 ; Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > tempnull2 ; Tpetra::CrsMatrix< SC,LO,GO,NO > *result = 0 ; - - arg1 = farg1->ptr ? static_cast< Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg1->ptr) : &tempnull1; - arg2 = farg2->ptr ? static_cast< Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg2->ptr) : &tempnull2; - arg3 = *farg3; + + arg1 = farg1->cptr ? static_cast< Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg1->cptr) : &tempnull1; + arg2 = farg2->cptr ? static_cast< Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg2->cptr) : &tempnull2; + arg3 = static_cast< size_t >(*farg3); { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::CrsMatrix(Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,size_t)");; @@ -10629,7 +10677,7 @@ SWIGEXPORT SwigClassWrapper _wrap_new_TpetraCrsMatrix__SWIG_5(SwigClassWrapper c SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::CrsMatrix(Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,size_t)", SWIG_UnknownError, "An unknown exception occurred", return SwigClassWrapper_uninitialized()); } } - fresult.ptr = result ? new Teuchos::RCP< Tpetra::CrsMatrix >(result SWIG_NO_NULL_DELETER_1) : NULL; + fresult.cptr = result ? new Teuchos::RCP< Tpetra::CrsMatrix >(result SWIG_NO_NULL_DELETER_1) : NULL; fresult.mem = SWIG_MOVE; return fresult; } @@ -10642,9 +10690,9 @@ SWIGEXPORT SwigClassWrapper _wrap_new_TpetraCrsMatrix__SWIG_6(SwigClassWrapper c Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::crs_graph_type const > tempnull1 ; Teuchos::RCP< Teuchos::ParameterList > tempnull2 ; Tpetra::CrsMatrix< SC,LO,GO,NO > *result = 0 ; - - arg1 = farg1->ptr ? static_cast< Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::crs_graph_type const > * >(farg1->ptr) : &tempnull1; - arg2 = farg2->ptr ? static_cast< Teuchos::RCP< Teuchos::ParameterList > * >(farg2->ptr) : &tempnull2; + + arg1 = farg1->cptr ? static_cast< Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::crs_graph_type const > * >(farg1->cptr) : &tempnull1; + arg2 = farg2->cptr ? static_cast< Teuchos::RCP< Teuchos::ParameterList > * >(farg2->cptr) : &tempnull2; { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::CrsMatrix(Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::crs_graph_type const > const &,Teuchos::RCP< Teuchos::ParameterList > const &)");; @@ -10668,7 +10716,7 @@ SWIGEXPORT SwigClassWrapper _wrap_new_TpetraCrsMatrix__SWIG_6(SwigClassWrapper c SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::CrsMatrix(Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::crs_graph_type const > const &,Teuchos::RCP< Teuchos::ParameterList > const &)", SWIG_UnknownError, "An unknown exception occurred", return SwigClassWrapper_uninitialized()); } } - fresult.ptr = result ? new Teuchos::RCP< Tpetra::CrsMatrix >(result SWIG_NO_NULL_DELETER_1) : NULL; + fresult.cptr = result ? new Teuchos::RCP< Tpetra::CrsMatrix >(result SWIG_NO_NULL_DELETER_1) : NULL; fresult.mem = SWIG_MOVE; return fresult; } @@ -10680,7 +10728,7 @@ SWIGEXPORT SwigClassWrapper _wrap_new_TpetraCrsMatrix__SWIG_7(SwigClassWrapper c Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::crs_graph_type const > tempnull1 ; Tpetra::CrsMatrix< SC,LO,GO,NO > *result = 0 ; - arg1 = farg1->ptr ? static_cast< Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::crs_graph_type const > * >(farg1->ptr) : &tempnull1; + arg1 = farg1->cptr ? static_cast< Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::crs_graph_type const > * >(farg1->cptr) : &tempnull1; { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::CrsMatrix(Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::crs_graph_type const > const &)");; @@ -10704,7 +10752,7 @@ SWIGEXPORT SwigClassWrapper _wrap_new_TpetraCrsMatrix__SWIG_7(SwigClassWrapper c SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::CrsMatrix(Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::crs_graph_type const > const &)", SWIG_UnknownError, "An unknown exception occurred", return SwigClassWrapper_uninitialized()); } } - fresult.ptr = result ? new Teuchos::RCP< Tpetra::CrsMatrix >(result SWIG_NO_NULL_DELETER_1) : NULL; + fresult.cptr = result ? new Teuchos::RCP< Tpetra::CrsMatrix >(result SWIG_NO_NULL_DELETER_1) : NULL; fresult.mem = SWIG_MOVE; return fresult; } @@ -10719,10 +10767,10 @@ SWIGEXPORT SwigClassWrapper _wrap_new_TpetraCrsMatrix__SWIG_8(SwigClassWrapper c Teuchos::RCP< Teuchos::ParameterList > tempnull3 ; Tpetra::CrsMatrix< SC,LO,GO,NO > *result = 0 ; - arg1 = farg1->ptr ? static_cast< Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::crs_graph_type const > * >(farg1->ptr) : &tempnull1; - SWIG_check_nonnull(*farg2, "Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::local_matrix_type::values_type const &", "SwigUnknownClass", "Tpetra::CrsMatrix< SC,LO,GO,NO >::CrsMatrix(Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::crs_graph_type const > const &,Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::local_matrix_type::values_type const &,Teuchos::RCP< Teuchos::ParameterList > const &)", return SwigClassWrapper_uninitialized()); - arg2 = static_cast< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::local_matrix_type::values_type * >(farg2->ptr); - arg3 = farg3->ptr ? static_cast< Teuchos::RCP< Teuchos::ParameterList > * >(farg3->ptr) : &tempnull3; + arg1 = farg1->cptr ? static_cast< Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::crs_graph_type const > * >(farg1->cptr) : &tempnull1; + SWIG_check_nonnull(*farg2, "Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::local_matrix_type::values_type const &", "SWIGTYPE_KokkosSparse__CrsMatrixT_Tpetra__CrsMatrixT_doub1E12GN", "Tpetra::CrsMatrix< SC,LO,GO,NO >::CrsMatrix(Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::crs_graph_type const > const &,Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::local_matrix_type::values_type const &,Teuchos::RCP< Teuchos::ParameterList > const &)", return SwigClassWrapper_uninitialized()); + arg2 = static_cast< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::local_matrix_type::values_type * >(farg2->cptr); + arg3 = farg3->cptr ? static_cast< Teuchos::RCP< Teuchos::ParameterList > * >(farg3->cptr) : &tempnull3; { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::CrsMatrix(Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::crs_graph_type const > const &,Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::local_matrix_type::values_type const &,Teuchos::RCP< Teuchos::ParameterList > const &)");; @@ -10746,7 +10794,7 @@ SWIGEXPORT SwigClassWrapper _wrap_new_TpetraCrsMatrix__SWIG_8(SwigClassWrapper c SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::CrsMatrix(Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::crs_graph_type const > const &,Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::local_matrix_type::values_type const &,Teuchos::RCP< Teuchos::ParameterList > const &)", SWIG_UnknownError, "An unknown exception occurred", return SwigClassWrapper_uninitialized()); } } - fresult.ptr = result ? new Teuchos::RCP< Tpetra::CrsMatrix >(result SWIG_NO_NULL_DELETER_1) : NULL; + fresult.cptr = result ? new Teuchos::RCP< Tpetra::CrsMatrix >(result SWIG_NO_NULL_DELETER_1) : NULL; fresult.mem = SWIG_MOVE; return fresult; } @@ -10759,9 +10807,9 @@ SWIGEXPORT SwigClassWrapper _wrap_new_TpetraCrsMatrix__SWIG_9(SwigClassWrapper c Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::crs_graph_type const > tempnull1 ; Tpetra::CrsMatrix< SC,LO,GO,NO > *result = 0 ; - arg1 = farg1->ptr ? static_cast< Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::crs_graph_type const > * >(farg1->ptr) : &tempnull1; - SWIG_check_nonnull(*farg2, "Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::local_matrix_type::values_type const &", "SwigUnknownClass", "Tpetra::CrsMatrix< SC,LO,GO,NO >::CrsMatrix(Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::crs_graph_type const > const &,Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::local_matrix_type::values_type const &)", return SwigClassWrapper_uninitialized()); - arg2 = static_cast< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::local_matrix_type::values_type * >(farg2->ptr); + arg1 = farg1->cptr ? static_cast< Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::crs_graph_type const > * >(farg1->cptr) : &tempnull1; + SWIG_check_nonnull(*farg2, "Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::local_matrix_type::values_type const &", "SWIGTYPE_KokkosSparse__CrsMatrixT_Tpetra__CrsMatrixT_doub1E12GN", "Tpetra::CrsMatrix< SC,LO,GO,NO >::CrsMatrix(Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::crs_graph_type const > const &,Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::local_matrix_type::values_type const &)", return SwigClassWrapper_uninitialized()); + arg2 = static_cast< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::local_matrix_type::values_type * >(farg2->cptr); { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::CrsMatrix(Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::crs_graph_type const > const &,Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::local_matrix_type::values_type const &)");; @@ -10785,7 +10833,7 @@ SWIGEXPORT SwigClassWrapper _wrap_new_TpetraCrsMatrix__SWIG_9(SwigClassWrapper c SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::CrsMatrix(Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::crs_graph_type const > const &,Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::local_matrix_type::values_type const &)", SWIG_UnknownError, "An unknown exception occurred", return SwigClassWrapper_uninitialized()); } } - fresult.ptr = result ? new Teuchos::RCP< Tpetra::CrsMatrix >(result SWIG_NO_NULL_DELETER_1) : NULL; + fresult.cptr = result ? new Teuchos::RCP< Tpetra::CrsMatrix >(result SWIG_NO_NULL_DELETER_1) : NULL; fresult.mem = SWIG_MOVE; return fresult; } @@ -10795,8 +10843,8 @@ SWIGEXPORT void _wrap_delete_TpetraCrsMatrix(SwigClassWrapper const *farg1) { Tpetra::CrsMatrix< SC,LO,GO,NO > *arg1 = (Tpetra::CrsMatrix< SC,LO,GO,NO > *) 0 ; Teuchos::RCP< Tpetra::CrsMatrix< SC,LO,GO,NO > > *smartarg1 ; - smartarg1 = static_cast< Teuchos::RCP< Tpetra::CrsMatrix >* >(farg1->ptr); - arg1 = smartarg1 ? smartarg1->get() : NULL; + smartarg1 = static_cast< Teuchos::RCP< Tpetra::CrsMatrix >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::CrsMatrix* >(smartarg1->get()) : NULL; { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::~CrsMatrix()");; @@ -10828,10 +10876,12 @@ SWIGEXPORT void _wrap_TpetraCrsMatrix_setAllToScalar(SwigClassWrapper const *far Tpetra::CrsMatrix< SC,LO,GO,NO > *arg1 = (Tpetra::CrsMatrix< SC,LO,GO,NO > *) 0 ; double *arg2 = 0 ; Teuchos::RCP< Tpetra::CrsMatrix< SC,LO,GO,NO > > *smartarg1 ; + double temp2 ; - smartarg1 = static_cast< Teuchos::RCP< Tpetra::CrsMatrix >* >(farg1->ptr); - arg1 = smartarg1 ? smartarg1->get() : NULL; - arg2 = reinterpret_cast< double * >(const_cast< double* >(farg2)); + smartarg1 = static_cast< Teuchos::RCP< Tpetra::CrsMatrix >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::CrsMatrix* >(smartarg1->get()) : NULL; + temp2 = static_cast< double >(*farg2); + arg2 = &temp2; { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::setAllToScalar(double const &)");; @@ -10863,10 +10913,12 @@ SWIGEXPORT void _wrap_TpetraCrsMatrix_scale(SwigClassWrapper const *farg1, doubl Tpetra::CrsMatrix< SC,LO,GO,NO > *arg1 = (Tpetra::CrsMatrix< SC,LO,GO,NO > *) 0 ; double *arg2 = 0 ; Teuchos::RCP< Tpetra::CrsMatrix< SC,LO,GO,NO > > *smartarg1 ; + double temp2 ; - smartarg1 = static_cast< Teuchos::RCP< Tpetra::CrsMatrix >* >(farg1->ptr); - arg1 = smartarg1 ? smartarg1->get() : NULL; - arg2 = reinterpret_cast< double * >(const_cast< double* >(farg2)); + smartarg1 = static_cast< Teuchos::RCP< Tpetra::CrsMatrix >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::CrsMatrix* >(smartarg1->get()) : NULL; + temp2 = static_cast< double >(*farg2); + arg2 = &temp2; { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::scale(double const &)");; @@ -10898,8 +10950,8 @@ SWIGEXPORT void _wrap_TpetraCrsMatrix_globalAssemble(SwigClassWrapper const *far Tpetra::CrsMatrix< SC,LO,GO,NO > *arg1 = (Tpetra::CrsMatrix< SC,LO,GO,NO > *) 0 ; Teuchos::RCP< Tpetra::CrsMatrix< SC,LO,GO,NO > > *smartarg1 ; - smartarg1 = static_cast< Teuchos::RCP< Tpetra::CrsMatrix >* >(farg1->ptr); - arg1 = smartarg1 ? smartarg1->get() : NULL; + smartarg1 = static_cast< Teuchos::RCP< Tpetra::CrsMatrix >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::CrsMatrix* >(smartarg1->get()) : NULL; { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::globalAssemble()");; @@ -10933,9 +10985,9 @@ SWIGEXPORT void _wrap_TpetraCrsMatrix_resumeFill__SWIG_0(SwigClassWrapper const Teuchos::RCP< Tpetra::CrsMatrix< SC,LO,GO,NO > > *smartarg1 ; Teuchos::RCP< Teuchos::ParameterList > tempnull2 ; - smartarg1 = static_cast< Teuchos::RCP< Tpetra::CrsMatrix >* >(farg1->ptr); - arg1 = smartarg1 ? smartarg1->get() : NULL; - arg2 = farg2->ptr ? static_cast< Teuchos::RCP< Teuchos::ParameterList > * >(farg2->ptr) : &tempnull2; + smartarg1 = static_cast< Teuchos::RCP< Tpetra::CrsMatrix >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::CrsMatrix* >(smartarg1->get()) : NULL; + arg2 = farg2->cptr ? static_cast< Teuchos::RCP< Teuchos::ParameterList > * >(farg2->cptr) : &tempnull2; { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::resumeFill(Teuchos::RCP< Teuchos::ParameterList > const &)");; @@ -10967,8 +11019,8 @@ SWIGEXPORT void _wrap_TpetraCrsMatrix_resumeFill__SWIG_1(SwigClassWrapper const Tpetra::CrsMatrix< SC,LO,GO,NO > *arg1 = (Tpetra::CrsMatrix< SC,LO,GO,NO > *) 0 ; Teuchos::RCP< Tpetra::CrsMatrix< SC,LO,GO,NO > > *smartarg1 ; - smartarg1 = static_cast< Teuchos::RCP< Tpetra::CrsMatrix >* >(farg1->ptr); - arg1 = smartarg1 ? smartarg1->get() : NULL; + smartarg1 = static_cast< Teuchos::RCP< Tpetra::CrsMatrix >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::CrsMatrix* >(smartarg1->get()) : NULL; { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::resumeFill()");; @@ -11006,11 +11058,11 @@ SWIGEXPORT void _wrap_TpetraCrsMatrix_fillComplete__SWIG_0(SwigClassWrapper cons Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > tempnull3 ; Teuchos::RCP< Teuchos::ParameterList > tempnull4 ; - smartarg1 = static_cast< Teuchos::RCP< Tpetra::CrsMatrix >* >(farg1->ptr); - arg1 = smartarg1 ? smartarg1->get() : NULL; - arg2 = farg2->ptr ? static_cast< Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg2->ptr) : &tempnull2; - arg3 = farg3->ptr ? static_cast< Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg3->ptr) : &tempnull3; - arg4 = farg4->ptr ? static_cast< Teuchos::RCP< Teuchos::ParameterList > * >(farg4->ptr) : &tempnull4; + smartarg1 = static_cast< Teuchos::RCP< Tpetra::CrsMatrix >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::CrsMatrix* >(smartarg1->get()) : NULL; + arg2 = farg2->cptr ? static_cast< Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg2->cptr) : &tempnull2; + arg3 = farg3->cptr ? static_cast< Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg3->cptr) : &tempnull3; + arg4 = farg4->cptr ? static_cast< Teuchos::RCP< Teuchos::ParameterList > * >(farg4->cptr) : &tempnull4; { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::fillComplete(Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Teuchos::ParameterList > const &)");; @@ -11046,10 +11098,10 @@ SWIGEXPORT void _wrap_TpetraCrsMatrix_fillComplete__SWIG_1(SwigClassWrapper cons Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > tempnull2 ; Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > tempnull3 ; - smartarg1 = static_cast< Teuchos::RCP< Tpetra::CrsMatrix >* >(farg1->ptr); - arg1 = smartarg1 ? smartarg1->get() : NULL; - arg2 = farg2->ptr ? static_cast< Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg2->ptr) : &tempnull2; - arg3 = farg3->ptr ? static_cast< Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg3->ptr) : &tempnull3; + smartarg1 = static_cast< Teuchos::RCP< Tpetra::CrsMatrix >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::CrsMatrix* >(smartarg1->get()) : NULL; + arg2 = farg2->cptr ? static_cast< Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg2->cptr) : &tempnull2; + arg3 = farg3->cptr ? static_cast< Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg3->cptr) : &tempnull3; { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::fillComplete(Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &)");; @@ -11083,9 +11135,9 @@ SWIGEXPORT void _wrap_TpetraCrsMatrix_fillComplete__SWIG_2(SwigClassWrapper cons Teuchos::RCP< Tpetra::CrsMatrix< SC,LO,GO,NO > > *smartarg1 ; Teuchos::RCP< Teuchos::ParameterList > tempnull2 ; - smartarg1 = static_cast< Teuchos::RCP< Tpetra::CrsMatrix >* >(farg1->ptr); - arg1 = smartarg1 ? smartarg1->get() : NULL; - arg2 = farg2->ptr ? static_cast< Teuchos::RCP< Teuchos::ParameterList > * >(farg2->ptr) : &tempnull2; + smartarg1 = static_cast< Teuchos::RCP< Tpetra::CrsMatrix >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::CrsMatrix* >(smartarg1->get()) : NULL; + arg2 = farg2->cptr ? static_cast< Teuchos::RCP< Teuchos::ParameterList > * >(farg2->cptr) : &tempnull2; { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::fillComplete(Teuchos::RCP< Teuchos::ParameterList > const &)");; @@ -11117,8 +11169,8 @@ SWIGEXPORT void _wrap_TpetraCrsMatrix_fillComplete__SWIG_3(SwigClassWrapper cons Tpetra::CrsMatrix< SC,LO,GO,NO > *arg1 = (Tpetra::CrsMatrix< SC,LO,GO,NO > *) 0 ; Teuchos::RCP< Tpetra::CrsMatrix< SC,LO,GO,NO > > *smartarg1 ; - smartarg1 = static_cast< Teuchos::RCP< Tpetra::CrsMatrix >* >(farg1->ptr); - arg1 = smartarg1 ? smartarg1->get() : NULL; + smartarg1 = static_cast< Teuchos::RCP< Tpetra::CrsMatrix >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::CrsMatrix* >(smartarg1->get()) : NULL; { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::fillComplete()");; @@ -11160,13 +11212,13 @@ SWIGEXPORT void _wrap_TpetraCrsMatrix_expertStaticFillComplete__SWIG_0(SwigClass Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::export_type const > tempnull5 ; Teuchos::RCP< Teuchos::ParameterList > tempnull6 ; - smartarg1 = static_cast< Teuchos::RCP< Tpetra::CrsMatrix >* >(farg1->ptr); - arg1 = smartarg1 ? smartarg1->get() : NULL; - arg2 = farg2->ptr ? static_cast< Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg2->ptr) : &tempnull2; - arg3 = farg3->ptr ? static_cast< Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg3->ptr) : &tempnull3; - arg4 = farg4->ptr ? static_cast< Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::import_type const > * >(farg4->ptr) : &tempnull4; - arg5 = farg5->ptr ? static_cast< Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::export_type const > * >(farg5->ptr) : &tempnull5; - arg6 = farg6->ptr ? static_cast< Teuchos::RCP< Teuchos::ParameterList > * >(farg6->ptr) : &tempnull6; + smartarg1 = static_cast< Teuchos::RCP< Tpetra::CrsMatrix >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::CrsMatrix* >(smartarg1->get()) : NULL; + arg2 = farg2->cptr ? static_cast< Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg2->cptr) : &tempnull2; + arg3 = farg3->cptr ? static_cast< Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg3->cptr) : &tempnull3; + arg4 = farg4->cptr ? static_cast< Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::import_type const > * >(farg4->cptr) : &tempnull4; + arg5 = farg5->cptr ? static_cast< Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::export_type const > * >(farg5->cptr) : &tempnull5; + arg6 = farg6->cptr ? static_cast< Teuchos::RCP< Teuchos::ParameterList > * >(farg6->cptr) : &tempnull6; { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::expertStaticFillComplete(Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::import_type const > const &,Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::export_type const > const &,Teuchos::RCP< Teuchos::ParameterList > const &)");; @@ -11206,12 +11258,12 @@ SWIGEXPORT void _wrap_TpetraCrsMatrix_expertStaticFillComplete__SWIG_1(SwigClass Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::import_type const > tempnull4 ; Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::export_type const > tempnull5 ; - smartarg1 = static_cast< Teuchos::RCP< Tpetra::CrsMatrix >* >(farg1->ptr); - arg1 = smartarg1 ? smartarg1->get() : NULL; - arg2 = farg2->ptr ? static_cast< Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg2->ptr) : &tempnull2; - arg3 = farg3->ptr ? static_cast< Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg3->ptr) : &tempnull3; - arg4 = farg4->ptr ? static_cast< Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::import_type const > * >(farg4->ptr) : &tempnull4; - arg5 = farg5->ptr ? static_cast< Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::export_type const > * >(farg5->ptr) : &tempnull5; + smartarg1 = static_cast< Teuchos::RCP< Tpetra::CrsMatrix >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::CrsMatrix* >(smartarg1->get()) : NULL; + arg2 = farg2->cptr ? static_cast< Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg2->cptr) : &tempnull2; + arg3 = farg3->cptr ? static_cast< Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg3->cptr) : &tempnull3; + arg4 = farg4->cptr ? static_cast< Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::import_type const > * >(farg4->cptr) : &tempnull4; + arg5 = farg5->cptr ? static_cast< Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::export_type const > * >(farg5->cptr) : &tempnull5; { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::expertStaticFillComplete(Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::import_type const > const &,Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::export_type const > const &)");; @@ -11249,11 +11301,11 @@ SWIGEXPORT void _wrap_TpetraCrsMatrix_expertStaticFillComplete__SWIG_2(SwigClass Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > tempnull3 ; Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::import_type const > tempnull4 ; - smartarg1 = static_cast< Teuchos::RCP< Tpetra::CrsMatrix >* >(farg1->ptr); - arg1 = smartarg1 ? smartarg1->get() : NULL; - arg2 = farg2->ptr ? static_cast< Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg2->ptr) : &tempnull2; - arg3 = farg3->ptr ? static_cast< Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg3->ptr) : &tempnull3; - arg4 = farg4->ptr ? static_cast< Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::import_type const > * >(farg4->ptr) : &tempnull4; + smartarg1 = static_cast< Teuchos::RCP< Tpetra::CrsMatrix >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::CrsMatrix* >(smartarg1->get()) : NULL; + arg2 = farg2->cptr ? static_cast< Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg2->cptr) : &tempnull2; + arg3 = farg3->cptr ? static_cast< Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg3->cptr) : &tempnull3; + arg4 = farg4->cptr ? static_cast< Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::import_type const > * >(farg4->cptr) : &tempnull4; { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::expertStaticFillComplete(Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::import_type const > const &)");; @@ -11289,10 +11341,10 @@ SWIGEXPORT void _wrap_TpetraCrsMatrix_expertStaticFillComplete__SWIG_3(SwigClass Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > tempnull2 ; Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > tempnull3 ; - smartarg1 = static_cast< Teuchos::RCP< Tpetra::CrsMatrix >* >(farg1->ptr); - arg1 = smartarg1 ? smartarg1->get() : NULL; - arg2 = farg2->ptr ? static_cast< Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg2->ptr) : &tempnull2; - arg3 = farg3->ptr ? static_cast< Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg3->ptr) : &tempnull3; + smartarg1 = static_cast< Teuchos::RCP< Tpetra::CrsMatrix >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::CrsMatrix* >(smartarg1->get()) : NULL; + arg2 = farg2->cptr ? static_cast< Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg2->cptr) : &tempnull2; + arg3 = farg3->cptr ? static_cast< Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg3->cptr) : &tempnull3; { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::expertStaticFillComplete(Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &)");; @@ -11326,9 +11378,9 @@ SWIGEXPORT void _wrap_TpetraCrsMatrix_replaceColMap(SwigClassWrapper const *farg Teuchos::RCP< Tpetra::CrsMatrix< SC,LO,GO,NO > > *smartarg1 ; Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > tempnull2 ; - smartarg1 = static_cast< Teuchos::RCP< Tpetra::CrsMatrix >* >(farg1->ptr); - arg1 = smartarg1 ? smartarg1->get() : NULL; - arg2 = farg2->ptr ? static_cast< Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg2->ptr) : &tempnull2; + smartarg1 = static_cast< Teuchos::RCP< Tpetra::CrsMatrix >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::CrsMatrix* >(smartarg1->get()) : NULL; + arg2 = farg2->cptr ? static_cast< Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg2->cptr) : &tempnull2; { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::replaceColMap(Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &)");; @@ -11367,13 +11419,13 @@ SWIGEXPORT void _wrap_TpetraCrsMatrix_reindexColumns__SWIG_0(SwigClassWrapper co Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > tempnull3 ; Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::import_type const > tempnull4 ; - smartarg1 = static_cast< Teuchos::RCP< Tpetra::CrsMatrix >* >(farg1->ptr); - arg1 = smartarg1 ? smartarg1->get() : NULL; - smartarg2 = static_cast< Teuchos::RCP< Tpetra::CrsGraph >* >(farg2->ptr); - arg2 = smartarg2 ? smartarg2->get() : NULL; - arg3 = farg3->ptr ? static_cast< Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg3->ptr) : &tempnull3; - arg4 = farg4->ptr ? static_cast< Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::import_type const > * >(farg4->ptr) : &tempnull4; - arg5 = *farg5; + smartarg1 = static_cast< Teuchos::RCP< Tpetra::CrsMatrix >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::CrsMatrix* >(smartarg1->get()) : NULL; + smartarg2 = static_cast< Teuchos::RCP< Tpetra::CrsGraph >* >(farg2->cptr); + arg2 = smartarg2 ? const_cast< Tpetra::CrsGraph* >(smartarg2->get()) : NULL; + arg3 = farg3->cptr ? static_cast< Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg3->cptr) : &tempnull3; + arg4 = farg4->cptr ? static_cast< Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::import_type const > * >(farg4->cptr) : &tempnull4; + arg5 = static_cast< bool >(*farg5); { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::reindexColumns(Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::crs_graph_type *const,Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::import_type const > const &,bool const)");; @@ -11411,12 +11463,12 @@ SWIGEXPORT void _wrap_TpetraCrsMatrix_reindexColumns__SWIG_1(SwigClassWrapper co Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > tempnull3 ; Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::import_type const > tempnull4 ; - smartarg1 = static_cast< Teuchos::RCP< Tpetra::CrsMatrix >* >(farg1->ptr); - arg1 = smartarg1 ? smartarg1->get() : NULL; - smartarg2 = static_cast< Teuchos::RCP< Tpetra::CrsGraph >* >(farg2->ptr); - arg2 = smartarg2 ? smartarg2->get() : NULL; - arg3 = farg3->ptr ? static_cast< Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg3->ptr) : &tempnull3; - arg4 = farg4->ptr ? static_cast< Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::import_type const > * >(farg4->ptr) : &tempnull4; + smartarg1 = static_cast< Teuchos::RCP< Tpetra::CrsMatrix >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::CrsMatrix* >(smartarg1->get()) : NULL; + smartarg2 = static_cast< Teuchos::RCP< Tpetra::CrsGraph >* >(farg2->cptr); + arg2 = smartarg2 ? const_cast< Tpetra::CrsGraph* >(smartarg2->get()) : NULL; + arg3 = farg3->cptr ? static_cast< Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg3->cptr) : &tempnull3; + arg4 = farg4->cptr ? static_cast< Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::import_type const > * >(farg4->cptr) : &tempnull4; { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::reindexColumns(Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::crs_graph_type *const,Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::import_type const > const &)");; @@ -11452,11 +11504,11 @@ SWIGEXPORT void _wrap_TpetraCrsMatrix_reindexColumns__SWIG_2(SwigClassWrapper co Teuchos::RCP< Tpetra::CrsGraph< LO,GO,NO > > *smartarg2 ; Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > tempnull3 ; - smartarg1 = static_cast< Teuchos::RCP< Tpetra::CrsMatrix >* >(farg1->ptr); - arg1 = smartarg1 ? smartarg1->get() : NULL; - smartarg2 = static_cast< Teuchos::RCP< Tpetra::CrsGraph >* >(farg2->ptr); - arg2 = smartarg2 ? smartarg2->get() : NULL; - arg3 = farg3->ptr ? static_cast< Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg3->ptr) : &tempnull3; + smartarg1 = static_cast< Teuchos::RCP< Tpetra::CrsMatrix >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::CrsMatrix* >(smartarg1->get()) : NULL; + smartarg2 = static_cast< Teuchos::RCP< Tpetra::CrsGraph >* >(farg2->cptr); + arg2 = smartarg2 ? const_cast< Tpetra::CrsGraph* >(smartarg2->get()) : NULL; + arg3 = farg3->cptr ? static_cast< Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg3->cptr) : &tempnull3; { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::reindexColumns(Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::crs_graph_type *const,Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &)");; @@ -11492,10 +11544,10 @@ SWIGEXPORT void _wrap_TpetraCrsMatrix_replaceDomainMapAndImporter(SwigClassWrapp Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > tempnull2 ; Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::import_type const > tempnull3 ; - smartarg1 = static_cast< Teuchos::RCP< Tpetra::CrsMatrix >* >(farg1->ptr); - arg1 = smartarg1 ? smartarg1->get() : NULL; - arg2 = farg2->ptr ? static_cast< Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg2->ptr) : &tempnull2; - arg3 = farg3->ptr ? static_cast< Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::import_type const > * >(farg3->ptr) : &tempnull3; + smartarg1 = static_cast< Teuchos::RCP< Tpetra::CrsMatrix >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::CrsMatrix* >(smartarg1->get()) : NULL; + arg2 = farg2->cptr ? static_cast< Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg2->cptr) : &tempnull2; + arg3 = farg3->cptr ? static_cast< Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::import_type const > * >(farg3->cptr) : &tempnull3; { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::replaceDomainMapAndImporter(Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::import_type const > &)");; @@ -11529,9 +11581,9 @@ SWIGEXPORT void _wrap_TpetraCrsMatrix_removeEmptyProcessesInPlace(SwigClassWrapp Teuchos::RCP< Tpetra::CrsMatrix< SC,LO,GO,NO > > *smartarg1 ; Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > tempnull2 ; - smartarg1 = static_cast< Teuchos::RCP< Tpetra::CrsMatrix >* >(farg1->ptr); - arg1 = smartarg1 ? smartarg1->get() : NULL; - arg2 = farg2->ptr ? static_cast< Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg2->ptr) : &tempnull2; + smartarg1 = static_cast< Teuchos::RCP< Tpetra::CrsMatrix >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::CrsMatrix* >(smartarg1->get()) : NULL; + arg2 = farg2->cptr ? static_cast< Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg2->cptr) : &tempnull2; { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::removeEmptyProcessesInPlace(Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &)");; @@ -11565,8 +11617,8 @@ SWIGEXPORT SwigClassWrapper _wrap_TpetraCrsMatrix_getComm(SwigClassWrapper const Teuchos::RCP< Tpetra::CrsMatrix< SC,LO,GO,NO > const > *smartarg1 ; Teuchos::RCP< Teuchos::Comm< int > const > result; - smartarg1 = static_cast< Teuchos::RCP >* >(farg1->ptr); - arg1 = smartarg1 ? const_cast*>(smartarg1->get()) : NULL; + smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::CrsMatrix* >(smartarg1->get()) : NULL; { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::getComm() const");; @@ -11590,7 +11642,7 @@ SWIGEXPORT SwigClassWrapper _wrap_TpetraCrsMatrix_getComm(SwigClassWrapper const SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::getComm() const", SWIG_UnknownError, "An unknown exception occurred", return SwigClassWrapper_uninitialized()); } } - fresult.ptr = (new Teuchos::RCP >(static_cast< const Teuchos::RCP >& >(result))); + fresult.cptr = (new Teuchos::RCP >(static_cast< const Teuchos::RCP >& >(result))); fresult.mem = SWIG_MOVE; return fresult; } @@ -11602,8 +11654,8 @@ SWIGEXPORT SwigClassWrapper _wrap_TpetraCrsMatrix_getRowMap(SwigClassWrapper con Teuchos::RCP< Tpetra::CrsMatrix< SC,LO,GO,NO > const > *smartarg1 ; Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > result; - smartarg1 = static_cast< Teuchos::RCP >* >(farg1->ptr); - arg1 = smartarg1 ? const_cast*>(smartarg1->get()) : NULL; + smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::CrsMatrix* >(smartarg1->get()) : NULL; { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::getRowMap() const");; @@ -11627,7 +11679,7 @@ SWIGEXPORT SwigClassWrapper _wrap_TpetraCrsMatrix_getRowMap(SwigClassWrapper con SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::getRowMap() const", SWIG_UnknownError, "An unknown exception occurred", return SwigClassWrapper_uninitialized()); } } - fresult.ptr = (new Teuchos::RCP >(static_cast< const Teuchos::RCP >& >(result))); + fresult.cptr = (new Teuchos::RCP >(static_cast< const Teuchos::RCP >& >(result))); fresult.mem = SWIG_MOVE; return fresult; } @@ -11639,8 +11691,8 @@ SWIGEXPORT SwigClassWrapper _wrap_TpetraCrsMatrix_getColMap(SwigClassWrapper con Teuchos::RCP< Tpetra::CrsMatrix< SC,LO,GO,NO > const > *smartarg1 ; Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > result; - smartarg1 = static_cast< Teuchos::RCP >* >(farg1->ptr); - arg1 = smartarg1 ? const_cast*>(smartarg1->get()) : NULL; + smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::CrsMatrix* >(smartarg1->get()) : NULL; { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::getColMap() const");; @@ -11664,7 +11716,7 @@ SWIGEXPORT SwigClassWrapper _wrap_TpetraCrsMatrix_getColMap(SwigClassWrapper con SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::getColMap() const", SWIG_UnknownError, "An unknown exception occurred", return SwigClassWrapper_uninitialized()); } } - fresult.ptr = (new Teuchos::RCP >(static_cast< const Teuchos::RCP >& >(result))); + fresult.cptr = (new Teuchos::RCP >(static_cast< const Teuchos::RCP >& >(result))); fresult.mem = SWIG_MOVE; return fresult; } @@ -11676,8 +11728,8 @@ SWIGEXPORT SwigClassWrapper _wrap_TpetraCrsMatrix_getCrsGraph(SwigClassWrapper c Teuchos::RCP< Tpetra::CrsMatrix< SC,LO,GO,NO > const > *smartarg1 ; Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::crs_graph_type const > result; - smartarg1 = static_cast< Teuchos::RCP >* >(farg1->ptr); - arg1 = smartarg1 ? const_cast*>(smartarg1->get()) : NULL; + smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::CrsMatrix* >(smartarg1->get()) : NULL; { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::getCrsGraph() const");; @@ -11701,20 +11753,20 @@ SWIGEXPORT SwigClassWrapper _wrap_TpetraCrsMatrix_getCrsGraph(SwigClassWrapper c SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::getCrsGraph() const", SWIG_UnknownError, "An unknown exception occurred", return SwigClassWrapper_uninitialized()); } } - fresult.ptr = (new Teuchos::RCP >(static_cast< const Teuchos::RCP >& >(result))); + fresult.cptr = (new Teuchos::RCP >(static_cast< const Teuchos::RCP >& >(result))); fresult.mem = SWIG_MOVE; return fresult; } -SWIGEXPORT unsigned long _wrap_TpetraCrsMatrix_getGlobalNumRows(SwigClassWrapper const *farg1) { - unsigned long fresult ; +SWIGEXPORT long _wrap_TpetraCrsMatrix_getGlobalNumRows(SwigClassWrapper const *farg1) { + long fresult ; Tpetra::CrsMatrix< SC,LO,GO,NO > *arg1 = (Tpetra::CrsMatrix< SC,LO,GO,NO > *) 0 ; Teuchos::RCP< Tpetra::CrsMatrix< SC,LO,GO,NO > const > *smartarg1 ; Tpetra::global_size_t result; - smartarg1 = static_cast< Teuchos::RCP >* >(farg1->ptr); - arg1 = smartarg1 ? const_cast*>(smartarg1->get()) : NULL; + smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::CrsMatrix* >(smartarg1->get()) : NULL; { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::getGlobalNumRows() const");; @@ -11738,19 +11790,19 @@ SWIGEXPORT unsigned long _wrap_TpetraCrsMatrix_getGlobalNumRows(SwigClassWrapper SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::getGlobalNumRows() const", SWIG_UnknownError, "An unknown exception occurred", return 0); } } - fresult = result; + fresult = static_cast< Tpetra::global_size_t >(result); return fresult; } -SWIGEXPORT unsigned long _wrap_TpetraCrsMatrix_getGlobalNumCols(SwigClassWrapper const *farg1) { - unsigned long fresult ; +SWIGEXPORT long _wrap_TpetraCrsMatrix_getGlobalNumCols(SwigClassWrapper const *farg1) { + long fresult ; Tpetra::CrsMatrix< SC,LO,GO,NO > *arg1 = (Tpetra::CrsMatrix< SC,LO,GO,NO > *) 0 ; Teuchos::RCP< Tpetra::CrsMatrix< SC,LO,GO,NO > const > *smartarg1 ; Tpetra::global_size_t result; - smartarg1 = static_cast< Teuchos::RCP >* >(farg1->ptr); - arg1 = smartarg1 ? const_cast*>(smartarg1->get()) : NULL; + smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::CrsMatrix* >(smartarg1->get()) : NULL; { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::getGlobalNumCols() const");; @@ -11774,7 +11826,7 @@ SWIGEXPORT unsigned long _wrap_TpetraCrsMatrix_getGlobalNumCols(SwigClassWrapper SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::getGlobalNumCols() const", SWIG_UnknownError, "An unknown exception occurred", return 0); } } - fresult = result; + fresult = static_cast< Tpetra::global_size_t >(result); return fresult; } @@ -11785,8 +11837,8 @@ SWIGEXPORT size_t _wrap_TpetraCrsMatrix_getNodeNumRows(SwigClassWrapper const *f Teuchos::RCP< Tpetra::CrsMatrix< SC,LO,GO,NO > const > *smartarg1 ; size_t result; - smartarg1 = static_cast< Teuchos::RCP >* >(farg1->ptr); - arg1 = smartarg1 ? const_cast*>(smartarg1->get()) : NULL; + smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::CrsMatrix* >(smartarg1->get()) : NULL; { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::getNodeNumRows() const");; @@ -11810,7 +11862,7 @@ SWIGEXPORT size_t _wrap_TpetraCrsMatrix_getNodeNumRows(SwigClassWrapper const *f SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::getNodeNumRows() const", SWIG_UnknownError, "An unknown exception occurred", return 0); } } - fresult = result; + fresult = static_cast< size_t >(result); return fresult; } @@ -11821,8 +11873,8 @@ SWIGEXPORT size_t _wrap_TpetraCrsMatrix_getNodeNumCols(SwigClassWrapper const *f Teuchos::RCP< Tpetra::CrsMatrix< SC,LO,GO,NO > const > *smartarg1 ; size_t result; - smartarg1 = static_cast< Teuchos::RCP >* >(farg1->ptr); - arg1 = smartarg1 ? const_cast*>(smartarg1->get()) : NULL; + smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::CrsMatrix* >(smartarg1->get()) : NULL; { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::getNodeNumCols() const");; @@ -11846,19 +11898,19 @@ SWIGEXPORT size_t _wrap_TpetraCrsMatrix_getNodeNumCols(SwigClassWrapper const *f SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::getNodeNumCols() const", SWIG_UnknownError, "An unknown exception occurred", return 0); } } - fresult = result; + fresult = static_cast< size_t >(result); return fresult; } -SWIGEXPORT unsigned long _wrap_TpetraCrsMatrix_getGlobalNumEntries(SwigClassWrapper const *farg1) { - unsigned long fresult ; +SWIGEXPORT long _wrap_TpetraCrsMatrix_getGlobalNumEntries(SwigClassWrapper const *farg1) { + long fresult ; Tpetra::CrsMatrix< SC,LO,GO,NO > *arg1 = (Tpetra::CrsMatrix< SC,LO,GO,NO > *) 0 ; Teuchos::RCP< Tpetra::CrsMatrix< SC,LO,GO,NO > const > *smartarg1 ; Tpetra::global_size_t result; - smartarg1 = static_cast< Teuchos::RCP >* >(farg1->ptr); - arg1 = smartarg1 ? const_cast*>(smartarg1->get()) : NULL; + smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::CrsMatrix* >(smartarg1->get()) : NULL; { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::getGlobalNumEntries() const");; @@ -11882,7 +11934,7 @@ SWIGEXPORT unsigned long _wrap_TpetraCrsMatrix_getGlobalNumEntries(SwigClassWrap SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::getGlobalNumEntries() const", SWIG_UnknownError, "An unknown exception occurred", return 0); } } - fresult = result; + fresult = static_cast< Tpetra::global_size_t >(result); return fresult; } @@ -11893,8 +11945,8 @@ SWIGEXPORT size_t _wrap_TpetraCrsMatrix_getNodeNumEntries(SwigClassWrapper const Teuchos::RCP< Tpetra::CrsMatrix< SC,LO,GO,NO > const > *smartarg1 ; size_t result; - smartarg1 = static_cast< Teuchos::RCP >* >(farg1->ptr); - arg1 = smartarg1 ? const_cast*>(smartarg1->get()) : NULL; + smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::CrsMatrix* >(smartarg1->get()) : NULL; { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::getNodeNumEntries() const");; @@ -11918,7 +11970,7 @@ SWIGEXPORT size_t _wrap_TpetraCrsMatrix_getNodeNumEntries(SwigClassWrapper const SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::getNodeNumEntries() const", SWIG_UnknownError, "An unknown exception occurred", return 0); } } - fresult = result; + fresult = static_cast< size_t >(result); return fresult; } @@ -11930,9 +11982,9 @@ SWIGEXPORT size_t _wrap_TpetraCrsMatrix_getNumEntriesInGlobalRow(SwigClassWrappe Teuchos::RCP< Tpetra::CrsMatrix< SC,LO,GO,NO > const > *smartarg1 ; size_t result; - smartarg1 = static_cast< Teuchos::RCP >* >(farg1->ptr); - arg1 = smartarg1 ? const_cast*>(smartarg1->get()) : NULL; - arg2 = *farg2; + smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::CrsMatrix* >(smartarg1->get()) : NULL; + arg2 = static_cast< long long >(*farg2); { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::getNumEntriesInGlobalRow(long long) const");; @@ -11956,7 +12008,7 @@ SWIGEXPORT size_t _wrap_TpetraCrsMatrix_getNumEntriesInGlobalRow(SwigClassWrappe SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::getNumEntriesInGlobalRow(long long) const", SWIG_UnknownError, "An unknown exception occurred", return 0); } } - fresult = result; + fresult = static_cast< size_t >(result); return fresult; } @@ -11968,8 +12020,8 @@ SWIGEXPORT size_t _wrap_TpetraCrsMatrix_getNumEntriesInLocalRow(SwigClassWrapper Teuchos::RCP< Tpetra::CrsMatrix< SC,LO,GO,NO > const > *smartarg1 ; size_t result; - smartarg1 = static_cast< Teuchos::RCP >* >(farg1->ptr); - arg1 = smartarg1 ? const_cast*>(smartarg1->get()) : NULL; + smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::CrsMatrix* >(smartarg1->get()) : NULL; arg2 = *farg2 - 1; { // Make sure no unhandled exceptions exist before performing a new action @@ -11994,19 +12046,19 @@ SWIGEXPORT size_t _wrap_TpetraCrsMatrix_getNumEntriesInLocalRow(SwigClassWrapper SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::getNumEntriesInLocalRow(int) const", SWIG_UnknownError, "An unknown exception occurred", return 0); } } - fresult = result; + fresult = static_cast< size_t >(result); return fresult; } -SWIGEXPORT unsigned long _wrap_TpetraCrsMatrix_getGlobalNumDiagsImpl(SwigClassWrapper const *farg1) { - unsigned long fresult ; +SWIGEXPORT long _wrap_TpetraCrsMatrix_getGlobalNumDiagsImpl(SwigClassWrapper const *farg1) { + long fresult ; Tpetra::CrsMatrix< SC,LO,GO,NO > *arg1 = (Tpetra::CrsMatrix< SC,LO,GO,NO > *) 0 ; Teuchos::RCP< Tpetra::CrsMatrix< SC,LO,GO,NO > const > *smartarg1 ; Tpetra::global_size_t result; - - smartarg1 = static_cast< Teuchos::RCP >* >(farg1->ptr); - arg1 = smartarg1 ? const_cast*>(smartarg1->get()) : NULL; + + smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::CrsMatrix* >(smartarg1->get()) : NULL; { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::getGlobalNumDiagsImpl() const");; @@ -12030,19 +12082,19 @@ SWIGEXPORT unsigned long _wrap_TpetraCrsMatrix_getGlobalNumDiagsImpl(SwigClassWr SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::getGlobalNumDiagsImpl() const", SWIG_UnknownError, "An unknown exception occurred", return 0); } } - fresult = result; + fresult = static_cast< Tpetra::global_size_t >(result); return fresult; } -SWIGEXPORT unsigned long _wrap_TpetraCrsMatrix_getGlobalNumDiags(SwigClassWrapper const *farg1) { - unsigned long fresult ; +SWIGEXPORT long _wrap_TpetraCrsMatrix_getGlobalNumDiags(SwigClassWrapper const *farg1) { + long fresult ; Tpetra::CrsMatrix< SC,LO,GO,NO > *arg1 = (Tpetra::CrsMatrix< SC,LO,GO,NO > *) 0 ; Teuchos::RCP< Tpetra::CrsMatrix< SC,LO,GO,NO > const > *smartarg1 ; Tpetra::global_size_t result; - smartarg1 = static_cast< Teuchos::RCP >* >(farg1->ptr); - arg1 = smartarg1 ? const_cast*>(smartarg1->get()) : NULL; + smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::CrsMatrix* >(smartarg1->get()) : NULL; { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::getGlobalNumDiags() const");; @@ -12066,7 +12118,7 @@ SWIGEXPORT unsigned long _wrap_TpetraCrsMatrix_getGlobalNumDiags(SwigClassWrappe SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::getGlobalNumDiags() const", SWIG_UnknownError, "An unknown exception occurred", return 0); } } - fresult = result; + fresult = static_cast< Tpetra::global_size_t >(result); return fresult; } @@ -12076,9 +12128,9 @@ SWIGEXPORT size_t _wrap_TpetraCrsMatrix_getNodeNumDiagsImpl(SwigClassWrapper con Tpetra::CrsMatrix< SC,LO,GO,NO > *arg1 = (Tpetra::CrsMatrix< SC,LO,GO,NO > *) 0 ; Teuchos::RCP< Tpetra::CrsMatrix< SC,LO,GO,NO > const > *smartarg1 ; size_t result; - - smartarg1 = static_cast< Teuchos::RCP >* >(farg1->ptr); - arg1 = smartarg1 ? const_cast*>(smartarg1->get()) : NULL; + + smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::CrsMatrix* >(smartarg1->get()) : NULL; { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::getNodeNumDiagsImpl() const");; @@ -12102,7 +12154,7 @@ SWIGEXPORT size_t _wrap_TpetraCrsMatrix_getNodeNumDiagsImpl(SwigClassWrapper con SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::getNodeNumDiagsImpl() const", SWIG_UnknownError, "An unknown exception occurred", return 0); } } - fresult = result; + fresult = static_cast< size_t >(result); return fresult; } @@ -12113,8 +12165,8 @@ SWIGEXPORT size_t _wrap_TpetraCrsMatrix_getNodeNumDiags(SwigClassWrapper const * Teuchos::RCP< Tpetra::CrsMatrix< SC,LO,GO,NO > const > *smartarg1 ; size_t result; - smartarg1 = static_cast< Teuchos::RCP >* >(farg1->ptr); - arg1 = smartarg1 ? const_cast*>(smartarg1->get()) : NULL; + smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::CrsMatrix* >(smartarg1->get()) : NULL; { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::getNodeNumDiags() const");; @@ -12138,7 +12190,7 @@ SWIGEXPORT size_t _wrap_TpetraCrsMatrix_getNodeNumDiags(SwigClassWrapper const * SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::getNodeNumDiags() const", SWIG_UnknownError, "An unknown exception occurred", return 0); } } - fresult = result; + fresult = static_cast< size_t >(result); return fresult; } @@ -12149,8 +12201,8 @@ SWIGEXPORT size_t _wrap_TpetraCrsMatrix_getGlobalMaxNumRowEntries(SwigClassWrapp Teuchos::RCP< Tpetra::CrsMatrix< SC,LO,GO,NO > const > *smartarg1 ; size_t result; - smartarg1 = static_cast< Teuchos::RCP >* >(farg1->ptr); - arg1 = smartarg1 ? const_cast*>(smartarg1->get()) : NULL; + smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::CrsMatrix* >(smartarg1->get()) : NULL; { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::getGlobalMaxNumRowEntries() const");; @@ -12174,7 +12226,7 @@ SWIGEXPORT size_t _wrap_TpetraCrsMatrix_getGlobalMaxNumRowEntries(SwigClassWrapp SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::getGlobalMaxNumRowEntries() const", SWIG_UnknownError, "An unknown exception occurred", return 0); } } - fresult = result; + fresult = static_cast< size_t >(result); return fresult; } @@ -12185,8 +12237,8 @@ SWIGEXPORT size_t _wrap_TpetraCrsMatrix_getNodeMaxNumRowEntries(SwigClassWrapper Teuchos::RCP< Tpetra::CrsMatrix< SC,LO,GO,NO > const > *smartarg1 ; size_t result; - smartarg1 = static_cast< Teuchos::RCP >* >(farg1->ptr); - arg1 = smartarg1 ? const_cast*>(smartarg1->get()) : NULL; + smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::CrsMatrix* >(smartarg1->get()) : NULL; { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::getNodeMaxNumRowEntries() const");; @@ -12210,7 +12262,7 @@ SWIGEXPORT size_t _wrap_TpetraCrsMatrix_getNodeMaxNumRowEntries(SwigClassWrapper SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::getNodeMaxNumRowEntries() const", SWIG_UnknownError, "An unknown exception occurred", return 0); } } - fresult = result; + fresult = static_cast< size_t >(result); return fresult; } @@ -12221,8 +12273,8 @@ SWIGEXPORT bool _wrap_TpetraCrsMatrix_hasColMap(SwigClassWrapper const *farg1) { Teuchos::RCP< Tpetra::CrsMatrix< SC,LO,GO,NO > const > *smartarg1 ; bool result; - smartarg1 = static_cast< Teuchos::RCP >* >(farg1->ptr); - arg1 = smartarg1 ? const_cast*>(smartarg1->get()) : NULL; + smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::CrsMatrix* >(smartarg1->get()) : NULL; { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::hasColMap() const");; @@ -12246,7 +12298,7 @@ SWIGEXPORT bool _wrap_TpetraCrsMatrix_hasColMap(SwigClassWrapper const *farg1) { SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::hasColMap() const", SWIG_UnknownError, "An unknown exception occurred", return 0); } } - fresult = result; + fresult = static_cast< bool >(result); return fresult; } @@ -12256,9 +12308,9 @@ SWIGEXPORT bool _wrap_TpetraCrsMatrix_isLowerTriangularImpl(SwigClassWrapper con Tpetra::CrsMatrix< SC,LO,GO,NO > *arg1 = (Tpetra::CrsMatrix< SC,LO,GO,NO > *) 0 ; Teuchos::RCP< Tpetra::CrsMatrix< SC,LO,GO,NO > const > *smartarg1 ; bool result; - - smartarg1 = static_cast< Teuchos::RCP >* >(farg1->ptr); - arg1 = smartarg1 ? const_cast*>(smartarg1->get()) : NULL; + + smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::CrsMatrix* >(smartarg1->get()) : NULL; { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::isLowerTriangularImpl() const");; @@ -12282,7 +12334,7 @@ SWIGEXPORT bool _wrap_TpetraCrsMatrix_isLowerTriangularImpl(SwigClassWrapper con SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::isLowerTriangularImpl() const", SWIG_UnknownError, "An unknown exception occurred", return 0); } } - fresult = result; + fresult = static_cast< bool >(result); return fresult; } @@ -12293,8 +12345,8 @@ SWIGEXPORT bool _wrap_TpetraCrsMatrix_isLowerTriangular(SwigClassWrapper const * Teuchos::RCP< Tpetra::CrsMatrix< SC,LO,GO,NO > const > *smartarg1 ; bool result; - smartarg1 = static_cast< Teuchos::RCP >* >(farg1->ptr); - arg1 = smartarg1 ? const_cast*>(smartarg1->get()) : NULL; + smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::CrsMatrix* >(smartarg1->get()) : NULL; { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::isLowerTriangular() const");; @@ -12318,7 +12370,7 @@ SWIGEXPORT bool _wrap_TpetraCrsMatrix_isLowerTriangular(SwigClassWrapper const * SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::isLowerTriangular() const", SWIG_UnknownError, "An unknown exception occurred", return 0); } } - fresult = result; + fresult = static_cast< bool >(result); return fresult; } @@ -12328,9 +12380,9 @@ SWIGEXPORT bool _wrap_TpetraCrsMatrix_isUpperTriangularImpl(SwigClassWrapper con Tpetra::CrsMatrix< SC,LO,GO,NO > *arg1 = (Tpetra::CrsMatrix< SC,LO,GO,NO > *) 0 ; Teuchos::RCP< Tpetra::CrsMatrix< SC,LO,GO,NO > const > *smartarg1 ; bool result; - - smartarg1 = static_cast< Teuchos::RCP >* >(farg1->ptr); - arg1 = smartarg1 ? const_cast*>(smartarg1->get()) : NULL; + + smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::CrsMatrix* >(smartarg1->get()) : NULL; { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::isUpperTriangularImpl() const");; @@ -12354,7 +12406,7 @@ SWIGEXPORT bool _wrap_TpetraCrsMatrix_isUpperTriangularImpl(SwigClassWrapper con SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::isUpperTriangularImpl() const", SWIG_UnknownError, "An unknown exception occurred", return 0); } } - fresult = result; + fresult = static_cast< bool >(result); return fresult; } @@ -12365,8 +12417,8 @@ SWIGEXPORT bool _wrap_TpetraCrsMatrix_isUpperTriangular(SwigClassWrapper const * Teuchos::RCP< Tpetra::CrsMatrix< SC,LO,GO,NO > const > *smartarg1 ; bool result; - smartarg1 = static_cast< Teuchos::RCP >* >(farg1->ptr); - arg1 = smartarg1 ? const_cast*>(smartarg1->get()) : NULL; + smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::CrsMatrix* >(smartarg1->get()) : NULL; { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::isUpperTriangular() const");; @@ -12390,7 +12442,7 @@ SWIGEXPORT bool _wrap_TpetraCrsMatrix_isUpperTriangular(SwigClassWrapper const * SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::isUpperTriangular() const", SWIG_UnknownError, "An unknown exception occurred", return 0); } } - fresult = result; + fresult = static_cast< bool >(result); return fresult; } @@ -12401,8 +12453,8 @@ SWIGEXPORT bool _wrap_TpetraCrsMatrix_isLocallyIndexed(SwigClassWrapper const *f Teuchos::RCP< Tpetra::CrsMatrix< SC,LO,GO,NO > const > *smartarg1 ; bool result; - smartarg1 = static_cast< Teuchos::RCP >* >(farg1->ptr); - arg1 = smartarg1 ? const_cast*>(smartarg1->get()) : NULL; + smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::CrsMatrix* >(smartarg1->get()) : NULL; { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::isLocallyIndexed() const");; @@ -12426,7 +12478,7 @@ SWIGEXPORT bool _wrap_TpetraCrsMatrix_isLocallyIndexed(SwigClassWrapper const *f SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::isLocallyIndexed() const", SWIG_UnknownError, "An unknown exception occurred", return 0); } } - fresult = result; + fresult = static_cast< bool >(result); return fresult; } @@ -12437,8 +12489,8 @@ SWIGEXPORT bool _wrap_TpetraCrsMatrix_isGloballyIndexed(SwigClassWrapper const * Teuchos::RCP< Tpetra::CrsMatrix< SC,LO,GO,NO > const > *smartarg1 ; bool result; - smartarg1 = static_cast< Teuchos::RCP >* >(farg1->ptr); - arg1 = smartarg1 ? const_cast*>(smartarg1->get()) : NULL; + smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::CrsMatrix* >(smartarg1->get()) : NULL; { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::isGloballyIndexed() const");; @@ -12462,7 +12514,7 @@ SWIGEXPORT bool _wrap_TpetraCrsMatrix_isGloballyIndexed(SwigClassWrapper const * SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::isGloballyIndexed() const", SWIG_UnknownError, "An unknown exception occurred", return 0); } } - fresult = result; + fresult = static_cast< bool >(result); return fresult; } @@ -12473,8 +12525,8 @@ SWIGEXPORT bool _wrap_TpetraCrsMatrix_isFillComplete(SwigClassWrapper const *far Teuchos::RCP< Tpetra::CrsMatrix< SC,LO,GO,NO > const > *smartarg1 ; bool result; - smartarg1 = static_cast< Teuchos::RCP >* >(farg1->ptr); - arg1 = smartarg1 ? const_cast*>(smartarg1->get()) : NULL; + smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::CrsMatrix* >(smartarg1->get()) : NULL; { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::isFillComplete() const");; @@ -12498,7 +12550,7 @@ SWIGEXPORT bool _wrap_TpetraCrsMatrix_isFillComplete(SwigClassWrapper const *far SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::isFillComplete() const", SWIG_UnknownError, "An unknown exception occurred", return 0); } } - fresult = result; + fresult = static_cast< bool >(result); return fresult; } @@ -12509,8 +12561,8 @@ SWIGEXPORT bool _wrap_TpetraCrsMatrix_isFillActive(SwigClassWrapper const *farg1 Teuchos::RCP< Tpetra::CrsMatrix< SC,LO,GO,NO > const > *smartarg1 ; bool result; - smartarg1 = static_cast< Teuchos::RCP >* >(farg1->ptr); - arg1 = smartarg1 ? const_cast*>(smartarg1->get()) : NULL; + smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::CrsMatrix* >(smartarg1->get()) : NULL; { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::isFillActive() const");; @@ -12534,7 +12586,7 @@ SWIGEXPORT bool _wrap_TpetraCrsMatrix_isFillActive(SwigClassWrapper const *farg1 SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::isFillActive() const", SWIG_UnknownError, "An unknown exception occurred", return 0); } } - fresult = result; + fresult = static_cast< bool >(result); return fresult; } @@ -12545,8 +12597,8 @@ SWIGEXPORT bool _wrap_TpetraCrsMatrix_isStorageOptimized(SwigClassWrapper const Teuchos::RCP< Tpetra::CrsMatrix< SC,LO,GO,NO > const > *smartarg1 ; bool result; - smartarg1 = static_cast< Teuchos::RCP >* >(farg1->ptr); - arg1 = smartarg1 ? const_cast*>(smartarg1->get()) : NULL; + smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::CrsMatrix* >(smartarg1->get()) : NULL; { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::isStorageOptimized() const");; @@ -12570,7 +12622,7 @@ SWIGEXPORT bool _wrap_TpetraCrsMatrix_isStorageOptimized(SwigClassWrapper const SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::isStorageOptimized() const", SWIG_UnknownError, "An unknown exception occurred", return 0); } } - fresult = result; + fresult = static_cast< bool >(result); return fresult; } @@ -12581,8 +12633,8 @@ SWIGEXPORT int _wrap_TpetraCrsMatrix_getProfileType(SwigClassWrapper const *farg Teuchos::RCP< Tpetra::CrsMatrix< SC,LO,GO,NO > const > *smartarg1 ; Tpetra::ProfileType result; - smartarg1 = static_cast< Teuchos::RCP >* >(farg1->ptr); - arg1 = smartarg1 ? const_cast*>(smartarg1->get()) : NULL; + smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::CrsMatrix* >(smartarg1->get()) : NULL; { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::getProfileType() const");; @@ -12617,8 +12669,8 @@ SWIGEXPORT bool _wrap_TpetraCrsMatrix_isStaticGraph(SwigClassWrapper const *farg Teuchos::RCP< Tpetra::CrsMatrix< SC,LO,GO,NO > const > *smartarg1 ; bool result; - smartarg1 = static_cast< Teuchos::RCP >* >(farg1->ptr); - arg1 = smartarg1 ? const_cast*>(smartarg1->get()) : NULL; + smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::CrsMatrix* >(smartarg1->get()) : NULL; { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::isStaticGraph() const");; @@ -12642,7 +12694,7 @@ SWIGEXPORT bool _wrap_TpetraCrsMatrix_isStaticGraph(SwigClassWrapper const *farg SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::isStaticGraph() const", SWIG_UnknownError, "An unknown exception occurred", return 0); } } - fresult = result; + fresult = static_cast< bool >(result); return fresult; } @@ -12653,8 +12705,8 @@ SWIGEXPORT double _wrap_TpetraCrsMatrix_getFrobeniusNorm(SwigClassWrapper const Teuchos::RCP< Tpetra::CrsMatrix< SC,LO,GO,NO > const > *smartarg1 ; Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::mag_type result; - smartarg1 = static_cast< Teuchos::RCP >* >(farg1->ptr); - arg1 = smartarg1 ? const_cast*>(smartarg1->get()) : NULL; + smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::CrsMatrix* >(smartarg1->get()) : NULL; { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::getFrobeniusNorm() const");; @@ -12678,7 +12730,7 @@ SWIGEXPORT double _wrap_TpetraCrsMatrix_getFrobeniusNorm(SwigClassWrapper const SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::getFrobeniusNorm() const", SWIG_UnknownError, "An unknown exception occurred", return 0); } } - fresult = result; + fresult = static_cast< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::mag_type >(result); return fresult; } @@ -12689,8 +12741,8 @@ SWIGEXPORT bool _wrap_TpetraCrsMatrix_supportsRowViews(SwigClassWrapper const *f Teuchos::RCP< Tpetra::CrsMatrix< SC,LO,GO,NO > const > *smartarg1 ; bool result; - smartarg1 = static_cast< Teuchos::RCP >* >(farg1->ptr); - arg1 = smartarg1 ? const_cast*>(smartarg1->get()) : NULL; + smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::CrsMatrix* >(smartarg1->get()) : NULL; { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::supportsRowViews() const");; @@ -12714,7 +12766,7 @@ SWIGEXPORT bool _wrap_TpetraCrsMatrix_supportsRowViews(SwigClassWrapper const *f SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::supportsRowViews() const", SWIG_UnknownError, "An unknown exception occurred", return 0); } } - fresult = result; + fresult = static_cast< bool >(result); return fresult; } @@ -12730,17 +12782,17 @@ SWIGEXPORT void _wrap_TpetraCrsMatrix_apply__SWIG_0(SwigClassWrapper const *farg Teuchos::RCP< Tpetra::MultiVector< SC,LO,GO,NO > const > *smartarg2 ; Teuchos::RCP< Tpetra::MultiVector< SC,LO,GO,NO > > *smartarg3 ; - smartarg1 = static_cast< Teuchos::RCP >* >(farg1->ptr); - arg1 = smartarg1 ? const_cast*>(smartarg1->get()) : NULL; + smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::CrsMatrix* >(smartarg1->get()) : NULL; SWIG_check_sp_nonnull(farg2, "Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > *", "TpetraMultiVector", "Tpetra::CrsMatrix< SC,LO,GO,NO >::apply(Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &,Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > &,Teuchos::ETransp,double,double) const", return ) - smartarg2 = static_cast< Teuchos::RCP >* >(farg2->ptr); - arg2 = const_cast*>(smartarg2->get()); + smartarg2 = static_cast< Teuchos::RCP >* >(farg2->cptr); + arg2 = const_cast< Tpetra::MultiVector* >(smartarg2->get()); SWIG_check_sp_nonnull(farg3, "Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > *", "TpetraMultiVector", "Tpetra::CrsMatrix< SC,LO,GO,NO >::apply(Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &,Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > &,Teuchos::ETransp,double,double) const", return ) - smartarg3 = static_cast< Teuchos::RCP< Tpetra::MultiVector >* >(farg3->ptr); - arg3 = smartarg3->get(); + smartarg3 = static_cast< Teuchos::RCP< Tpetra::MultiVector >* >(farg3->cptr); + arg3 = const_cast< Tpetra::MultiVector* >(smartarg3->get()); arg4 = static_cast< Teuchos::ETransp >(*farg4); - arg5 = *farg5; - arg6 = *farg6; + arg5 = static_cast< double >(*farg5); + arg6 = static_cast< double >(*farg6); { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::apply(Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &,Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > &,Teuchos::ETransp,double,double) const");; @@ -12778,16 +12830,16 @@ SWIGEXPORT void _wrap_TpetraCrsMatrix_apply__SWIG_1(SwigClassWrapper const *farg Teuchos::RCP< Tpetra::MultiVector< SC,LO,GO,NO > const > *smartarg2 ; Teuchos::RCP< Tpetra::MultiVector< SC,LO,GO,NO > > *smartarg3 ; - smartarg1 = static_cast< Teuchos::RCP >* >(farg1->ptr); - arg1 = smartarg1 ? const_cast*>(smartarg1->get()) : NULL; + smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::CrsMatrix* >(smartarg1->get()) : NULL; SWIG_check_sp_nonnull(farg2, "Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > *", "TpetraMultiVector", "Tpetra::CrsMatrix< SC,LO,GO,NO >::apply(Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &,Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > &,Teuchos::ETransp,double) const", return ) - smartarg2 = static_cast< Teuchos::RCP >* >(farg2->ptr); - arg2 = const_cast*>(smartarg2->get()); + smartarg2 = static_cast< Teuchos::RCP >* >(farg2->cptr); + arg2 = const_cast< Tpetra::MultiVector* >(smartarg2->get()); SWIG_check_sp_nonnull(farg3, "Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > *", "TpetraMultiVector", "Tpetra::CrsMatrix< SC,LO,GO,NO >::apply(Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &,Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > &,Teuchos::ETransp,double) const", return ) - smartarg3 = static_cast< Teuchos::RCP< Tpetra::MultiVector >* >(farg3->ptr); - arg3 = smartarg3->get(); + smartarg3 = static_cast< Teuchos::RCP< Tpetra::MultiVector >* >(farg3->cptr); + arg3 = const_cast< Tpetra::MultiVector* >(smartarg3->get()); arg4 = static_cast< Teuchos::ETransp >(*farg4); - arg5 = *farg5; + arg5 = static_cast< double >(*farg5); { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::apply(Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &,Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > &,Teuchos::ETransp,double) const");; @@ -12824,14 +12876,14 @@ SWIGEXPORT void _wrap_TpetraCrsMatrix_apply__SWIG_2(SwigClassWrapper const *farg Teuchos::RCP< Tpetra::MultiVector< SC,LO,GO,NO > const > *smartarg2 ; Teuchos::RCP< Tpetra::MultiVector< SC,LO,GO,NO > > *smartarg3 ; - smartarg1 = static_cast< Teuchos::RCP >* >(farg1->ptr); - arg1 = smartarg1 ? const_cast*>(smartarg1->get()) : NULL; + smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::CrsMatrix* >(smartarg1->get()) : NULL; SWIG_check_sp_nonnull(farg2, "Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > *", "TpetraMultiVector", "Tpetra::CrsMatrix< SC,LO,GO,NO >::apply(Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &,Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > &,Teuchos::ETransp) const", return ) - smartarg2 = static_cast< Teuchos::RCP >* >(farg2->ptr); - arg2 = const_cast*>(smartarg2->get()); + smartarg2 = static_cast< Teuchos::RCP >* >(farg2->cptr); + arg2 = const_cast< Tpetra::MultiVector* >(smartarg2->get()); SWIG_check_sp_nonnull(farg3, "Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > *", "TpetraMultiVector", "Tpetra::CrsMatrix< SC,LO,GO,NO >::apply(Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &,Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > &,Teuchos::ETransp) const", return ) - smartarg3 = static_cast< Teuchos::RCP< Tpetra::MultiVector >* >(farg3->ptr); - arg3 = smartarg3->get(); + smartarg3 = static_cast< Teuchos::RCP< Tpetra::MultiVector >* >(farg3->cptr); + arg3 = const_cast< Tpetra::MultiVector* >(smartarg3->get()); arg4 = static_cast< Teuchos::ETransp >(*farg4); { // Make sure no unhandled exceptions exist before performing a new action @@ -12868,14 +12920,14 @@ SWIGEXPORT void _wrap_TpetraCrsMatrix_apply__SWIG_3(SwigClassWrapper const *farg Teuchos::RCP< Tpetra::MultiVector< SC,LO,GO,NO > const > *smartarg2 ; Teuchos::RCP< Tpetra::MultiVector< SC,LO,GO,NO > > *smartarg3 ; - smartarg1 = static_cast< Teuchos::RCP >* >(farg1->ptr); - arg1 = smartarg1 ? const_cast*>(smartarg1->get()) : NULL; + smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::CrsMatrix* >(smartarg1->get()) : NULL; SWIG_check_sp_nonnull(farg2, "Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > *", "TpetraMultiVector", "Tpetra::CrsMatrix< SC,LO,GO,NO >::apply(Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &,Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > &) const", return ) - smartarg2 = static_cast< Teuchos::RCP >* >(farg2->ptr); - arg2 = const_cast*>(smartarg2->get()); + smartarg2 = static_cast< Teuchos::RCP >* >(farg2->cptr); + arg2 = const_cast< Tpetra::MultiVector* >(smartarg2->get()); SWIG_check_sp_nonnull(farg3, "Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > *", "TpetraMultiVector", "Tpetra::CrsMatrix< SC,LO,GO,NO >::apply(Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &,Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > &) const", return ) - smartarg3 = static_cast< Teuchos::RCP< Tpetra::MultiVector >* >(farg3->ptr); - arg3 = smartarg3->get(); + smartarg3 = static_cast< Teuchos::RCP< Tpetra::MultiVector >* >(farg3->cptr); + arg3 = const_cast< Tpetra::MultiVector* >(smartarg3->get()); { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::apply(Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &,Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > &) const");; @@ -12909,8 +12961,8 @@ SWIGEXPORT bool _wrap_TpetraCrsMatrix_hasTransposeApply(SwigClassWrapper const * Teuchos::RCP< Tpetra::CrsMatrix< SC,LO,GO,NO > const > *smartarg1 ; bool result; - smartarg1 = static_cast< Teuchos::RCP >* >(farg1->ptr); - arg1 = smartarg1 ? const_cast*>(smartarg1->get()) : NULL; + smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::CrsMatrix* >(smartarg1->get()) : NULL; { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::hasTransposeApply() const");; @@ -12934,7 +12986,7 @@ SWIGEXPORT bool _wrap_TpetraCrsMatrix_hasTransposeApply(SwigClassWrapper const * SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::hasTransposeApply() const", SWIG_UnknownError, "An unknown exception occurred", return 0); } } - fresult = result; + fresult = static_cast< bool >(result); return fresult; } @@ -12945,8 +12997,8 @@ SWIGEXPORT SwigClassWrapper _wrap_TpetraCrsMatrix_getDomainMap(SwigClassWrapper Teuchos::RCP< Tpetra::CrsMatrix< SC,LO,GO,NO > const > *smartarg1 ; Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > result; - smartarg1 = static_cast< Teuchos::RCP >* >(farg1->ptr); - arg1 = smartarg1 ? const_cast*>(smartarg1->get()) : NULL; + smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::CrsMatrix* >(smartarg1->get()) : NULL; { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::getDomainMap() const");; @@ -12970,7 +13022,7 @@ SWIGEXPORT SwigClassWrapper _wrap_TpetraCrsMatrix_getDomainMap(SwigClassWrapper SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::getDomainMap() const", SWIG_UnknownError, "An unknown exception occurred", return SwigClassWrapper_uninitialized()); } } - fresult.ptr = (new Teuchos::RCP >(static_cast< const Teuchos::RCP >& >(result))); + fresult.cptr = (new Teuchos::RCP >(static_cast< const Teuchos::RCP >& >(result))); fresult.mem = SWIG_MOVE; return fresult; } @@ -12982,8 +13034,8 @@ SWIGEXPORT SwigClassWrapper _wrap_TpetraCrsMatrix_getRangeMap(SwigClassWrapper c Teuchos::RCP< Tpetra::CrsMatrix< SC,LO,GO,NO > const > *smartarg1 ; Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > result; - smartarg1 = static_cast< Teuchos::RCP >* >(farg1->ptr); - arg1 = smartarg1 ? const_cast*>(smartarg1->get()) : NULL; + smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::CrsMatrix* >(smartarg1->get()) : NULL; { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::getRangeMap() const");; @@ -13007,7 +13059,7 @@ SWIGEXPORT SwigClassWrapper _wrap_TpetraCrsMatrix_getRangeMap(SwigClassWrapper c SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::getRangeMap() const", SWIG_UnknownError, "An unknown exception occurred", return SwigClassWrapper_uninitialized()); } } - fresult.ptr = (new Teuchos::RCP >(static_cast< const Teuchos::RCP >& >(result))); + fresult.cptr = (new Teuchos::RCP >(static_cast< const Teuchos::RCP >& >(result))); fresult.mem = SWIG_MOVE; return fresult; } @@ -13025,21 +13077,23 @@ SWIGEXPORT void _wrap_TpetraCrsMatrix_gaussSeidel(SwigClassWrapper const *farg1, Teuchos::RCP< Tpetra::MultiVector< SC,LO,GO,NO > const > *smartarg2 ; Teuchos::RCP< Tpetra::MultiVector< SC,LO,GO,NO > > *smartarg3 ; Teuchos::RCP< Tpetra::MultiVector< SC,LO,GO,NO > const > *smartarg4 ; + double temp5 ; - smartarg1 = static_cast< Teuchos::RCP >* >(farg1->ptr); - arg1 = smartarg1 ? const_cast*>(smartarg1->get()) : NULL; + smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::CrsMatrix* >(smartarg1->get()) : NULL; SWIG_check_sp_nonnull(farg2, "Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > *", "TpetraMultiVector", "Tpetra::CrsMatrix< SC,LO,GO,NO >::gaussSeidel(Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &,Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > &,Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &,double const &,Tpetra::ESweepDirection const,int const) const", return ) - smartarg2 = static_cast< Teuchos::RCP >* >(farg2->ptr); - arg2 = const_cast*>(smartarg2->get()); + smartarg2 = static_cast< Teuchos::RCP >* >(farg2->cptr); + arg2 = const_cast< Tpetra::MultiVector* >(smartarg2->get()); SWIG_check_sp_nonnull(farg3, "Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > *", "TpetraMultiVector", "Tpetra::CrsMatrix< SC,LO,GO,NO >::gaussSeidel(Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &,Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > &,Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &,double const &,Tpetra::ESweepDirection const,int const) const", return ) - smartarg3 = static_cast< Teuchos::RCP< Tpetra::MultiVector >* >(farg3->ptr); - arg3 = smartarg3->get(); + smartarg3 = static_cast< Teuchos::RCP< Tpetra::MultiVector >* >(farg3->cptr); + arg3 = const_cast< Tpetra::MultiVector* >(smartarg3->get()); SWIG_check_sp_nonnull(farg4, "Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > *", "TpetraMultiVector", "Tpetra::CrsMatrix< SC,LO,GO,NO >::gaussSeidel(Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &,Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > &,Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &,double const &,Tpetra::ESweepDirection const,int const) const", return ) - smartarg4 = static_cast< Teuchos::RCP >* >(farg4->ptr); - arg4 = const_cast*>(smartarg4->get()); - arg5 = reinterpret_cast< double * >(const_cast< double* >(farg5)); + smartarg4 = static_cast< Teuchos::RCP >* >(farg4->cptr); + arg4 = const_cast< Tpetra::MultiVector* >(smartarg4->get()); + temp5 = static_cast< double >(*farg5); + arg5 = &temp5; arg6 = static_cast< Tpetra::ESweepDirection >(*farg6); - arg7 = *farg7; + arg7 = static_cast< int >(*farg7); { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::gaussSeidel(Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &,Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > &,Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &,double const &,Tpetra::ESweepDirection const,int const) const");; @@ -13080,22 +13134,24 @@ SWIGEXPORT void _wrap_TpetraCrsMatrix_gaussSeidelCopy(SwigClassWrapper const *fa Teuchos::RCP< Tpetra::MultiVector< SC,LO,GO,NO > > *smartarg2 ; Teuchos::RCP< Tpetra::MultiVector< SC,LO,GO,NO > const > *smartarg3 ; Teuchos::RCP< Tpetra::MultiVector< SC,LO,GO,NO > const > *smartarg4 ; + double temp5 ; - smartarg1 = static_cast< Teuchos::RCP >* >(farg1->ptr); - arg1 = smartarg1 ? const_cast*>(smartarg1->get()) : NULL; + smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::CrsMatrix* >(smartarg1->get()) : NULL; SWIG_check_sp_nonnull(farg2, "Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > *", "TpetraMultiVector", "Tpetra::CrsMatrix< SC,LO,GO,NO >::gaussSeidelCopy(Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > &,Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &,Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &,double const &,Tpetra::ESweepDirection const,int const,bool const) const", return ) - smartarg2 = static_cast< Teuchos::RCP< Tpetra::MultiVector >* >(farg2->ptr); - arg2 = smartarg2->get(); + smartarg2 = static_cast< Teuchos::RCP< Tpetra::MultiVector >* >(farg2->cptr); + arg2 = const_cast< Tpetra::MultiVector* >(smartarg2->get()); SWIG_check_sp_nonnull(farg3, "Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > *", "TpetraMultiVector", "Tpetra::CrsMatrix< SC,LO,GO,NO >::gaussSeidelCopy(Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > &,Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &,Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &,double const &,Tpetra::ESweepDirection const,int const,bool const) const", return ) - smartarg3 = static_cast< Teuchos::RCP >* >(farg3->ptr); - arg3 = const_cast*>(smartarg3->get()); + smartarg3 = static_cast< Teuchos::RCP >* >(farg3->cptr); + arg3 = const_cast< Tpetra::MultiVector* >(smartarg3->get()); SWIG_check_sp_nonnull(farg4, "Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > *", "TpetraMultiVector", "Tpetra::CrsMatrix< SC,LO,GO,NO >::gaussSeidelCopy(Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > &,Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &,Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &,double const &,Tpetra::ESweepDirection const,int const,bool const) const", return ) - smartarg4 = static_cast< Teuchos::RCP >* >(farg4->ptr); - arg4 = const_cast*>(smartarg4->get()); - arg5 = reinterpret_cast< double * >(const_cast< double* >(farg5)); + smartarg4 = static_cast< Teuchos::RCP >* >(farg4->cptr); + arg4 = const_cast< Tpetra::MultiVector* >(smartarg4->get()); + temp5 = static_cast< double >(*farg5); + arg5 = &temp5; arg6 = static_cast< Tpetra::ESweepDirection >(*farg6); - arg7 = *farg7; - arg8 = *farg8; + arg7 = static_cast< int >(*farg7); + arg8 = static_cast< bool >(*farg8); { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::gaussSeidelCopy(Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > &,Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &,Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &,double const &,Tpetra::ESweepDirection const,int const,bool const) const");; @@ -13129,8 +13185,8 @@ SWIGEXPORT SwigArrayWrapper _wrap_TpetraCrsMatrix_description(SwigClassWrapper c Teuchos::RCP< Tpetra::CrsMatrix< SC,LO,GO,NO > const > *smartarg1 ; std::string result; - smartarg1 = static_cast< Teuchos::RCP >* >(farg1->ptr); - arg1 = smartarg1 ? const_cast*>(smartarg1->get()) : NULL; + smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::CrsMatrix* >(smartarg1->get()) : NULL; { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::description() const");; @@ -13179,15 +13235,15 @@ SWIGEXPORT void _wrap_TpetraCrsMatrix_importAndFillComplete__SWIG_0(SwigClassWra Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > tempnull5 ; Teuchos::RCP< Teuchos::ParameterList > tempnull6 ; - smartarg1 = static_cast< Teuchos::RCP >* >(farg1->ptr); - arg1 = smartarg1 ? const_cast*>(smartarg1->get()) : NULL; - arg2 = farg2->ptr ? static_cast< Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > > * >(farg2->ptr) : &tempnull2; + smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::CrsMatrix* >(smartarg1->get()) : NULL; + arg2 = farg2->cptr ? static_cast< Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > > * >(farg2->cptr) : &tempnull2; SWIG_check_sp_nonnull(farg3, "Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::import_type *", "TpetraImport", "Tpetra::CrsMatrix< SC,LO,GO,NO >::importAndFillComplete(Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > > &,Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::import_type const &,Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Teuchos::ParameterList > const &) const", return ) - smartarg3 = static_cast< Teuchos::RCP >* >(farg3->ptr); - arg3 = const_cast*>(smartarg3->get()); - arg4 = farg4->ptr ? static_cast< Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg4->ptr) : &tempnull4; - arg5 = farg5->ptr ? static_cast< Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg5->ptr) : &tempnull5; - arg6 = farg6->ptr ? static_cast< Teuchos::RCP< Teuchos::ParameterList > * >(farg6->ptr) : &tempnull6; + smartarg3 = static_cast< Teuchos::RCP >* >(farg3->cptr); + arg3 = const_cast< Tpetra::Import* >(smartarg3->get()); + arg4 = farg4->cptr ? static_cast< Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg4->cptr) : &tempnull4; + arg5 = farg5->cptr ? static_cast< Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg5->cptr) : &tempnull5; + arg6 = farg6->cptr ? static_cast< Teuchos::RCP< Teuchos::ParameterList > * >(farg6->cptr) : &tempnull6; { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::importAndFillComplete(Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > > &,Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::import_type const &,Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Teuchos::ParameterList > const &) const");; @@ -13227,14 +13283,14 @@ SWIGEXPORT void _wrap_TpetraCrsMatrix_importAndFillComplete__SWIG_1(SwigClassWra Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > tempnull4 ; Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > tempnull5 ; - smartarg1 = static_cast< Teuchos::RCP >* >(farg1->ptr); - arg1 = smartarg1 ? const_cast*>(smartarg1->get()) : NULL; - arg2 = farg2->ptr ? static_cast< Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > > * >(farg2->ptr) : &tempnull2; + smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::CrsMatrix* >(smartarg1->get()) : NULL; + arg2 = farg2->cptr ? static_cast< Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > > * >(farg2->cptr) : &tempnull2; SWIG_check_sp_nonnull(farg3, "Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::import_type *", "TpetraImport", "Tpetra::CrsMatrix< SC,LO,GO,NO >::importAndFillComplete(Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > > &,Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::import_type const &,Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &) const", return ) - smartarg3 = static_cast< Teuchos::RCP >* >(farg3->ptr); - arg3 = const_cast*>(smartarg3->get()); - arg4 = farg4->ptr ? static_cast< Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg4->ptr) : &tempnull4; - arg5 = farg5->ptr ? static_cast< Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg5->ptr) : &tempnull5; + smartarg3 = static_cast< Teuchos::RCP >* >(farg3->cptr); + arg3 = const_cast< Tpetra::Import* >(smartarg3->get()); + arg4 = farg4->cptr ? static_cast< Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg4->cptr) : &tempnull4; + arg5 = farg5->cptr ? static_cast< Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg5->cptr) : &tempnull5; { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::importAndFillComplete(Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > > &,Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::import_type const &,Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &) const");; @@ -13278,18 +13334,18 @@ SWIGEXPORT void _wrap_TpetraCrsMatrix_importAndFillComplete__SWIG_2(SwigClassWra Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > tempnull6 ; Teuchos::RCP< Teuchos::ParameterList > tempnull7 ; - smartarg1 = static_cast< Teuchos::RCP >* >(farg1->ptr); - arg1 = smartarg1 ? const_cast*>(smartarg1->get()) : NULL; - arg2 = farg2->ptr ? static_cast< Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > > * >(farg2->ptr) : &tempnull2; + smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::CrsMatrix* >(smartarg1->get()) : NULL; + arg2 = farg2->cptr ? static_cast< Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > > * >(farg2->cptr) : &tempnull2; SWIG_check_sp_nonnull(farg3, "Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::import_type *", "TpetraImport", "Tpetra::CrsMatrix< SC,LO,GO,NO >::importAndFillComplete(Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > > &,Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::import_type const &,Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::import_type const &,Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Teuchos::ParameterList > const &) const", return ) - smartarg3 = static_cast< Teuchos::RCP >* >(farg3->ptr); - arg3 = const_cast*>(smartarg3->get()); + smartarg3 = static_cast< Teuchos::RCP >* >(farg3->cptr); + arg3 = const_cast< Tpetra::Import* >(smartarg3->get()); SWIG_check_sp_nonnull(farg4, "Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::import_type *", "TpetraImport", "Tpetra::CrsMatrix< SC,LO,GO,NO >::importAndFillComplete(Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > > &,Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::import_type const &,Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::import_type const &,Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Teuchos::ParameterList > const &) const", return ) - smartarg4 = static_cast< Teuchos::RCP >* >(farg4->ptr); - arg4 = const_cast*>(smartarg4->get()); - arg5 = farg5->ptr ? static_cast< Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg5->ptr) : &tempnull5; - arg6 = farg6->ptr ? static_cast< Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg6->ptr) : &tempnull6; - arg7 = farg7->ptr ? static_cast< Teuchos::RCP< Teuchos::ParameterList > * >(farg7->ptr) : &tempnull7; + smartarg4 = static_cast< Teuchos::RCP >* >(farg4->cptr); + arg4 = const_cast< Tpetra::Import* >(smartarg4->get()); + arg5 = farg5->cptr ? static_cast< Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg5->cptr) : &tempnull5; + arg6 = farg6->cptr ? static_cast< Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg6->cptr) : &tempnull6; + arg7 = farg7->cptr ? static_cast< Teuchos::RCP< Teuchos::ParameterList > * >(farg7->cptr) : &tempnull7; { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::importAndFillComplete(Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > > &,Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::import_type const &,Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::import_type const &,Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Teuchos::ParameterList > const &) const");; @@ -13331,15 +13387,15 @@ SWIGEXPORT void _wrap_TpetraCrsMatrix_exportAndFillComplete__SWIG_0(SwigClassWra Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > tempnull5 ; Teuchos::RCP< Teuchos::ParameterList > tempnull6 ; - smartarg1 = static_cast< Teuchos::RCP >* >(farg1->ptr); - arg1 = smartarg1 ? const_cast*>(smartarg1->get()) : NULL; - arg2 = farg2->ptr ? static_cast< Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > > * >(farg2->ptr) : &tempnull2; + smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::CrsMatrix* >(smartarg1->get()) : NULL; + arg2 = farg2->cptr ? static_cast< Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > > * >(farg2->cptr) : &tempnull2; SWIG_check_sp_nonnull(farg3, "Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::export_type *", "TpetraExport", "Tpetra::CrsMatrix< SC,LO,GO,NO >::exportAndFillComplete(Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > > &,Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::export_type const &,Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Teuchos::ParameterList > const &) const", return ) - smartarg3 = static_cast< Teuchos::RCP >* >(farg3->ptr); - arg3 = const_cast*>(smartarg3->get()); - arg4 = farg4->ptr ? static_cast< Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg4->ptr) : &tempnull4; - arg5 = farg5->ptr ? static_cast< Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg5->ptr) : &tempnull5; - arg6 = farg6->ptr ? static_cast< Teuchos::RCP< Teuchos::ParameterList > * >(farg6->ptr) : &tempnull6; + smartarg3 = static_cast< Teuchos::RCP >* >(farg3->cptr); + arg3 = const_cast< Tpetra::Export* >(smartarg3->get()); + arg4 = farg4->cptr ? static_cast< Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg4->cptr) : &tempnull4; + arg5 = farg5->cptr ? static_cast< Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg5->cptr) : &tempnull5; + arg6 = farg6->cptr ? static_cast< Teuchos::RCP< Teuchos::ParameterList > * >(farg6->cptr) : &tempnull6; { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::exportAndFillComplete(Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > > &,Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::export_type const &,Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Teuchos::ParameterList > const &) const");; @@ -13379,14 +13435,14 @@ SWIGEXPORT void _wrap_TpetraCrsMatrix_exportAndFillComplete__SWIG_1(SwigClassWra Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > tempnull4 ; Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > tempnull5 ; - smartarg1 = static_cast< Teuchos::RCP >* >(farg1->ptr); - arg1 = smartarg1 ? const_cast*>(smartarg1->get()) : NULL; - arg2 = farg2->ptr ? static_cast< Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > > * >(farg2->ptr) : &tempnull2; + smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::CrsMatrix* >(smartarg1->get()) : NULL; + arg2 = farg2->cptr ? static_cast< Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > > * >(farg2->cptr) : &tempnull2; SWIG_check_sp_nonnull(farg3, "Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::export_type *", "TpetraExport", "Tpetra::CrsMatrix< SC,LO,GO,NO >::exportAndFillComplete(Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > > &,Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::export_type const &,Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &) const", return ) - smartarg3 = static_cast< Teuchos::RCP >* >(farg3->ptr); - arg3 = const_cast*>(smartarg3->get()); - arg4 = farg4->ptr ? static_cast< Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg4->ptr) : &tempnull4; - arg5 = farg5->ptr ? static_cast< Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg5->ptr) : &tempnull5; + smartarg3 = static_cast< Teuchos::RCP >* >(farg3->cptr); + arg3 = const_cast< Tpetra::Export* >(smartarg3->get()); + arg4 = farg4->cptr ? static_cast< Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg4->cptr) : &tempnull4; + arg5 = farg5->cptr ? static_cast< Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg5->cptr) : &tempnull5; { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::exportAndFillComplete(Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > > &,Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::export_type const &,Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &) const");; @@ -13424,13 +13480,13 @@ SWIGEXPORT void _wrap_TpetraCrsMatrix_exportAndFillComplete__SWIG_2(SwigClassWra Teuchos::RCP< Tpetra::Export< LO,GO,NO > const > *smartarg3 ; Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > tempnull4 ; - smartarg1 = static_cast< Teuchos::RCP >* >(farg1->ptr); - arg1 = smartarg1 ? const_cast*>(smartarg1->get()) : NULL; - arg2 = farg2->ptr ? static_cast< Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > > * >(farg2->ptr) : &tempnull2; + smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::CrsMatrix* >(smartarg1->get()) : NULL; + arg2 = farg2->cptr ? static_cast< Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > > * >(farg2->cptr) : &tempnull2; SWIG_check_sp_nonnull(farg3, "Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::export_type *", "TpetraExport", "Tpetra::CrsMatrix< SC,LO,GO,NO >::exportAndFillComplete(Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > > &,Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::export_type const &,Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &) const", return ) - smartarg3 = static_cast< Teuchos::RCP >* >(farg3->ptr); - arg3 = const_cast*>(smartarg3->get()); - arg4 = farg4->ptr ? static_cast< Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg4->ptr) : &tempnull4; + smartarg3 = static_cast< Teuchos::RCP >* >(farg3->cptr); + arg3 = const_cast< Tpetra::Export* >(smartarg3->get()); + arg4 = farg4->cptr ? static_cast< Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg4->cptr) : &tempnull4; { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::exportAndFillComplete(Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > > &,Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::export_type const &,Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &) const");; @@ -13466,12 +13522,12 @@ SWIGEXPORT void _wrap_TpetraCrsMatrix_exportAndFillComplete__SWIG_3(SwigClassWra Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > > tempnull2 ; Teuchos::RCP< Tpetra::Export< LO,GO,NO > const > *smartarg3 ; - smartarg1 = static_cast< Teuchos::RCP >* >(farg1->ptr); - arg1 = smartarg1 ? const_cast*>(smartarg1->get()) : NULL; - arg2 = farg2->ptr ? static_cast< Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > > * >(farg2->ptr) : &tempnull2; + smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::CrsMatrix* >(smartarg1->get()) : NULL; + arg2 = farg2->cptr ? static_cast< Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > > * >(farg2->cptr) : &tempnull2; SWIG_check_sp_nonnull(farg3, "Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::export_type *", "TpetraExport", "Tpetra::CrsMatrix< SC,LO,GO,NO >::exportAndFillComplete(Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > > &,Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::export_type const &) const", return ) - smartarg3 = static_cast< Teuchos::RCP >* >(farg3->ptr); - arg3 = const_cast*>(smartarg3->get()); + smartarg3 = static_cast< Teuchos::RCP >* >(farg3->cptr); + arg3 = const_cast< Tpetra::Export* >(smartarg3->get()); { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::exportAndFillComplete(Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > > &,Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::export_type const &) const");; @@ -13515,18 +13571,18 @@ SWIGEXPORT void _wrap_TpetraCrsMatrix_exportAndFillComplete__SWIG_4(SwigClassWra Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > tempnull6 ; Teuchos::RCP< Teuchos::ParameterList > tempnull7 ; - smartarg1 = static_cast< Teuchos::RCP >* >(farg1->ptr); - arg1 = smartarg1 ? const_cast*>(smartarg1->get()) : NULL; - arg2 = farg2->ptr ? static_cast< Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > > * >(farg2->ptr) : &tempnull2; + smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::CrsMatrix* >(smartarg1->get()) : NULL; + arg2 = farg2->cptr ? static_cast< Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > > * >(farg2->cptr) : &tempnull2; SWIG_check_sp_nonnull(farg3, "Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::export_type *", "TpetraExport", "Tpetra::CrsMatrix< SC,LO,GO,NO >::exportAndFillComplete(Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > > &,Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::export_type const &,Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::export_type const &,Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Teuchos::ParameterList > const &) const", return ) - smartarg3 = static_cast< Teuchos::RCP >* >(farg3->ptr); - arg3 = const_cast*>(smartarg3->get()); + smartarg3 = static_cast< Teuchos::RCP >* >(farg3->cptr); + arg3 = const_cast< Tpetra::Export* >(smartarg3->get()); SWIG_check_sp_nonnull(farg4, "Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::export_type *", "TpetraExport", "Tpetra::CrsMatrix< SC,LO,GO,NO >::exportAndFillComplete(Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > > &,Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::export_type const &,Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::export_type const &,Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Teuchos::ParameterList > const &) const", return ) - smartarg4 = static_cast< Teuchos::RCP >* >(farg4->ptr); - arg4 = const_cast*>(smartarg4->get()); - arg5 = farg5->ptr ? static_cast< Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg5->ptr) : &tempnull5; - arg6 = farg6->ptr ? static_cast< Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg6->ptr) : &tempnull6; - arg7 = farg7->ptr ? static_cast< Teuchos::RCP< Teuchos::ParameterList > * >(farg7->ptr) : &tempnull7; + smartarg4 = static_cast< Teuchos::RCP >* >(farg4->cptr); + arg4 = const_cast< Tpetra::Export* >(smartarg4->get()); + arg5 = farg5->cptr ? static_cast< Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg5->cptr) : &tempnull5; + arg6 = farg6->cptr ? static_cast< Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg6->cptr) : &tempnull6; + arg7 = farg7->cptr ? static_cast< Teuchos::RCP< Teuchos::ParameterList > * >(farg7->cptr) : &tempnull7; { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::exportAndFillComplete(Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > > &,Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::export_type const &,Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::export_type const &,Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Teuchos::ParameterList > const &) const");; @@ -13550,16 +13606,16 @@ SWIGEXPORT void _wrap_TpetraCrsMatrix_exportAndFillComplete__SWIG_4(SwigClassWra SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::exportAndFillComplete(Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > > &,Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::export_type const &,Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::export_type const &,Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Teuchos::ParameterList > const &) const", SWIG_UnknownError, "An unknown exception occurred", return ); } } - + } SWIGEXPORT void _wrap_TpetraCrsMatrix_computeGlobalConstants(SwigClassWrapper const *farg1) { Tpetra::CrsMatrix< SC,LO,GO,NO > *arg1 = (Tpetra::CrsMatrix< SC,LO,GO,NO > *) 0 ; Teuchos::RCP< Tpetra::CrsMatrix< SC,LO,GO,NO > > *smartarg1 ; - - smartarg1 = static_cast< Teuchos::RCP< Tpetra::CrsMatrix >* >(farg1->ptr); - arg1 = smartarg1 ? smartarg1->get() : NULL; + + smartarg1 = static_cast< Teuchos::RCP< Tpetra::CrsMatrix >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::CrsMatrix* >(smartarg1->get()) : NULL; { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::computeGlobalConstants()");; @@ -13593,8 +13649,8 @@ SWIGEXPORT bool _wrap_TpetraCrsMatrix_haveGlobalConstants(SwigClassWrapper const Teuchos::RCP< Tpetra::CrsMatrix< SC,LO,GO,NO > const > *smartarg1 ; bool result; - smartarg1 = static_cast< Teuchos::RCP >* >(farg1->ptr); - arg1 = smartarg1 ? const_cast*>(smartarg1->get()) : NULL; + smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::CrsMatrix* >(smartarg1->get()) : NULL; { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::haveGlobalConstants() const");; @@ -13618,7 +13674,7 @@ SWIGEXPORT bool _wrap_TpetraCrsMatrix_haveGlobalConstants(SwigClassWrapper const SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::haveGlobalConstants() const", SWIG_UnknownError, "An unknown exception occurred", return 0); } } - fresult = result; + fresult = static_cast< bool >(result); return fresult; } @@ -13633,11 +13689,11 @@ SWIGEXPORT SwigClassWrapper _wrap_new_TpetraCrsMatrix__SWIG_10(SwigClassWrapper Teuchos::RCP< Teuchos::ParameterList > tempnull4 ; Tpetra::CrsMatrix< SC,LO,GO,NO > *result = 0 ; - arg1 = farg1->ptr ? static_cast< Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg1->ptr) : &tempnull1; + arg1 = farg1->cptr ? static_cast< Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg1->cptr) : &tempnull1; (&arg2)->first = static_cast(farg2->data); (&arg2)->second = farg2->size; arg3 = static_cast< Tpetra::ProfileType >(*farg3); - arg4 = farg4->ptr ? static_cast< Teuchos::RCP< Teuchos::ParameterList > * >(farg4->ptr) : &tempnull4; + arg4 = farg4->cptr ? static_cast< Teuchos::RCP< Teuchos::ParameterList > * >(farg4->cptr) : &tempnull4; { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::CrsMatrix(Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,std::pair< std::size_t const *,std::size_t >,Tpetra::ProfileType,Teuchos::RCP< Teuchos::ParameterList > const &)");; @@ -13661,7 +13717,7 @@ SWIGEXPORT SwigClassWrapper _wrap_new_TpetraCrsMatrix__SWIG_10(SwigClassWrapper SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::CrsMatrix(Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,std::pair< std::size_t const *,std::size_t >,Tpetra::ProfileType,Teuchos::RCP< Teuchos::ParameterList > const &)", SWIG_UnknownError, "An unknown exception occurred", return SwigClassWrapper_uninitialized()); } } - fresult.ptr = result ? new Teuchos::RCP< Tpetra::CrsMatrix >(result SWIG_NO_NULL_DELETER_1) : NULL; + fresult.cptr = result ? new Teuchos::RCP< Tpetra::CrsMatrix >(result SWIG_NO_NULL_DELETER_1) : NULL; fresult.mem = SWIG_MOVE; return fresult; } @@ -13675,7 +13731,7 @@ SWIGEXPORT SwigClassWrapper _wrap_new_TpetraCrsMatrix__SWIG_11(SwigClassWrapper Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > tempnull1 ; Tpetra::CrsMatrix< SC,LO,GO,NO > *result = 0 ; - arg1 = farg1->ptr ? static_cast< Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg1->ptr) : &tempnull1; + arg1 = farg1->cptr ? static_cast< Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg1->cptr) : &tempnull1; (&arg2)->first = static_cast(farg2->data); (&arg2)->second = farg2->size; arg3 = static_cast< Tpetra::ProfileType >(*farg3); @@ -13702,7 +13758,7 @@ SWIGEXPORT SwigClassWrapper _wrap_new_TpetraCrsMatrix__SWIG_11(SwigClassWrapper SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::CrsMatrix(Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,std::pair< std::size_t const *,std::size_t >,Tpetra::ProfileType)", SWIG_UnknownError, "An unknown exception occurred", return SwigClassWrapper_uninitialized()); } } - fresult.ptr = result ? new Teuchos::RCP< Tpetra::CrsMatrix >(result SWIG_NO_NULL_DELETER_1) : NULL; + fresult.cptr = result ? new Teuchos::RCP< Tpetra::CrsMatrix >(result SWIG_NO_NULL_DELETER_1) : NULL; fresult.mem = SWIG_MOVE; return fresult; } @@ -13715,7 +13771,7 @@ SWIGEXPORT SwigClassWrapper _wrap_new_TpetraCrsMatrix__SWIG_12(SwigClassWrapper Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > tempnull1 ; Tpetra::CrsMatrix< SC,LO,GO,NO > *result = 0 ; - arg1 = farg1->ptr ? static_cast< Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg1->ptr) : &tempnull1; + arg1 = farg1->cptr ? static_cast< Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg1->cptr) : &tempnull1; (&arg2)->first = static_cast(farg2->data); (&arg2)->second = farg2->size; { @@ -13741,7 +13797,7 @@ SWIGEXPORT SwigClassWrapper _wrap_new_TpetraCrsMatrix__SWIG_12(SwigClassWrapper SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::CrsMatrix(Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,std::pair< std::size_t const *,std::size_t >)", SWIG_UnknownError, "An unknown exception occurred", return SwigClassWrapper_uninitialized()); } } - fresult.ptr = result ? new Teuchos::RCP< Tpetra::CrsMatrix >(result SWIG_NO_NULL_DELETER_1) : NULL; + fresult.cptr = result ? new Teuchos::RCP< Tpetra::CrsMatrix >(result SWIG_NO_NULL_DELETER_1) : NULL; fresult.mem = SWIG_MOVE; return fresult; } @@ -13759,12 +13815,12 @@ SWIGEXPORT SwigClassWrapper _wrap_new_TpetraCrsMatrix__SWIG_13(SwigClassWrapper Teuchos::RCP< Teuchos::ParameterList > tempnull5 ; Tpetra::CrsMatrix< SC,LO,GO,NO > *result = 0 ; - arg1 = farg1->ptr ? static_cast< Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg1->ptr) : &tempnull1; - arg2 = farg2->ptr ? static_cast< Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg2->ptr) : &tempnull2; + arg1 = farg1->cptr ? static_cast< Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg1->cptr) : &tempnull1; + arg2 = farg2->cptr ? static_cast< Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg2->cptr) : &tempnull2; (&arg3)->first = static_cast(farg3->data); (&arg3)->second = farg3->size; arg4 = static_cast< Tpetra::ProfileType >(*farg4); - arg5 = farg5->ptr ? static_cast< Teuchos::RCP< Teuchos::ParameterList > * >(farg5->ptr) : &tempnull5; + arg5 = farg5->cptr ? static_cast< Teuchos::RCP< Teuchos::ParameterList > * >(farg5->cptr) : &tempnull5; { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::CrsMatrix(Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,std::pair< std::size_t const *,std::size_t >,Tpetra::ProfileType,Teuchos::RCP< Teuchos::ParameterList > const &)");; @@ -13788,7 +13844,7 @@ SWIGEXPORT SwigClassWrapper _wrap_new_TpetraCrsMatrix__SWIG_13(SwigClassWrapper SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::CrsMatrix(Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,std::pair< std::size_t const *,std::size_t >,Tpetra::ProfileType,Teuchos::RCP< Teuchos::ParameterList > const &)", SWIG_UnknownError, "An unknown exception occurred", return SwigClassWrapper_uninitialized()); } } - fresult.ptr = result ? new Teuchos::RCP< Tpetra::CrsMatrix >(result SWIG_NO_NULL_DELETER_1) : NULL; + fresult.cptr = result ? new Teuchos::RCP< Tpetra::CrsMatrix >(result SWIG_NO_NULL_DELETER_1) : NULL; fresult.mem = SWIG_MOVE; return fresult; } @@ -13804,8 +13860,8 @@ SWIGEXPORT SwigClassWrapper _wrap_new_TpetraCrsMatrix__SWIG_14(SwigClassWrapper Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > tempnull2 ; Tpetra::CrsMatrix< SC,LO,GO,NO > *result = 0 ; - arg1 = farg1->ptr ? static_cast< Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg1->ptr) : &tempnull1; - arg2 = farg2->ptr ? static_cast< Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg2->ptr) : &tempnull2; + arg1 = farg1->cptr ? static_cast< Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg1->cptr) : &tempnull1; + arg2 = farg2->cptr ? static_cast< Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg2->cptr) : &tempnull2; (&arg3)->first = static_cast(farg3->data); (&arg3)->second = farg3->size; arg4 = static_cast< Tpetra::ProfileType >(*farg4); @@ -13832,7 +13888,7 @@ SWIGEXPORT SwigClassWrapper _wrap_new_TpetraCrsMatrix__SWIG_14(SwigClassWrapper SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::CrsMatrix(Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,std::pair< std::size_t const *,std::size_t >,Tpetra::ProfileType)", SWIG_UnknownError, "An unknown exception occurred", return SwigClassWrapper_uninitialized()); } } - fresult.ptr = result ? new Teuchos::RCP< Tpetra::CrsMatrix >(result SWIG_NO_NULL_DELETER_1) : NULL; + fresult.cptr = result ? new Teuchos::RCP< Tpetra::CrsMatrix >(result SWIG_NO_NULL_DELETER_1) : NULL; fresult.mem = SWIG_MOVE; return fresult; } @@ -13847,8 +13903,8 @@ SWIGEXPORT SwigClassWrapper _wrap_new_TpetraCrsMatrix__SWIG_15(SwigClassWrapper Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > tempnull2 ; Tpetra::CrsMatrix< SC,LO,GO,NO > *result = 0 ; - arg1 = farg1->ptr ? static_cast< Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg1->ptr) : &tempnull1; - arg2 = farg2->ptr ? static_cast< Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg2->ptr) : &tempnull2; + arg1 = farg1->cptr ? static_cast< Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg1->cptr) : &tempnull1; + arg2 = farg2->cptr ? static_cast< Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg2->cptr) : &tempnull2; (&arg3)->first = static_cast(farg3->data); (&arg3)->second = farg3->size; { @@ -13874,7 +13930,7 @@ SWIGEXPORT SwigClassWrapper _wrap_new_TpetraCrsMatrix__SWIG_15(SwigClassWrapper SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::CrsMatrix(Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,std::pair< std::size_t const *,std::size_t >)", SWIG_UnknownError, "An unknown exception occurred", return SwigClassWrapper_uninitialized()); } } - fresult.ptr = result ? new Teuchos::RCP< Tpetra::CrsMatrix >(result SWIG_NO_NULL_DELETER_1) : NULL; + fresult.cptr = result ? new Teuchos::RCP< Tpetra::CrsMatrix >(result SWIG_NO_NULL_DELETER_1) : NULL; fresult.mem = SWIG_MOVE; return fresult; } @@ -13893,15 +13949,15 @@ SWIGEXPORT SwigClassWrapper _wrap_new_TpetraCrsMatrix__SWIG_16(SwigClassWrapper Teuchos::RCP< Teuchos::ParameterList > tempnull6 ; Tpetra::CrsMatrix< SC,LO,GO,NO > *result = 0 ; - arg1 = farg1->ptr ? static_cast< Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg1->ptr) : &tempnull1; - arg2 = farg2->ptr ? static_cast< Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg2->ptr) : &tempnull2; + arg1 = farg1->cptr ? static_cast< Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg1->cptr) : &tempnull1; + arg2 = farg2->cptr ? static_cast< Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg2->cptr) : &tempnull2; (&arg3)->first = static_cast(farg3->data); (&arg3)->second = farg3->size; (&arg4)->first = static_cast(farg4->data); (&arg4)->second = farg4->size; (&arg5)->first = static_cast(farg5->data); (&arg5)->second = farg5->size; - arg6 = farg6->ptr ? static_cast< Teuchos::RCP< Teuchos::ParameterList > * >(farg6->ptr) : &tempnull6; + arg6 = farg6->cptr ? static_cast< Teuchos::RCP< Teuchos::ParameterList > * >(farg6->cptr) : &tempnull6; { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::CrsMatrix(Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,std::pair< std::size_t *,std::size_t >,std::pair< LO *,std::size_t >,std::pair< SC *,std::size_t >,Teuchos::RCP< Teuchos::ParameterList > const &)");; @@ -13925,7 +13981,7 @@ SWIGEXPORT SwigClassWrapper _wrap_new_TpetraCrsMatrix__SWIG_16(SwigClassWrapper SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::CrsMatrix(Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,std::pair< std::size_t *,std::size_t >,std::pair< LO *,std::size_t >,std::pair< SC *,std::size_t >,Teuchos::RCP< Teuchos::ParameterList > const &)", SWIG_UnknownError, "An unknown exception occurred", return SwigClassWrapper_uninitialized()); } } - fresult.ptr = result ? new Teuchos::RCP< Tpetra::CrsMatrix >(result SWIG_NO_NULL_DELETER_1) : NULL; + fresult.cptr = result ? new Teuchos::RCP< Tpetra::CrsMatrix >(result SWIG_NO_NULL_DELETER_1) : NULL; fresult.mem = SWIG_MOVE; return fresult; } @@ -13942,8 +13998,8 @@ SWIGEXPORT SwigClassWrapper _wrap_new_TpetraCrsMatrix__SWIG_17(SwigClassWrapper Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > tempnull2 ; Tpetra::CrsMatrix< SC,LO,GO,NO > *result = 0 ; - arg1 = farg1->ptr ? static_cast< Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg1->ptr) : &tempnull1; - arg2 = farg2->ptr ? static_cast< Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg2->ptr) : &tempnull2; + arg1 = farg1->cptr ? static_cast< Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg1->cptr) : &tempnull1; + arg2 = farg2->cptr ? static_cast< Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg2->cptr) : &tempnull2; (&arg3)->first = static_cast(farg3->data); (&arg3)->second = farg3->size; (&arg4)->first = static_cast(farg4->data); @@ -13973,7 +14029,7 @@ SWIGEXPORT SwigClassWrapper _wrap_new_TpetraCrsMatrix__SWIG_17(SwigClassWrapper SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::CrsMatrix(Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,std::pair< std::size_t *,std::size_t >,std::pair< LO *,std::size_t >,std::pair< SC *,std::size_t >)", SWIG_UnknownError, "An unknown exception occurred", return SwigClassWrapper_uninitialized()); } } - fresult.ptr = result ? new Teuchos::RCP< Tpetra::CrsMatrix >(result SWIG_NO_NULL_DELETER_1) : NULL; + fresult.cptr = result ? new Teuchos::RCP< Tpetra::CrsMatrix >(result SWIG_NO_NULL_DELETER_1) : NULL; fresult.mem = SWIG_MOVE; return fresult; } @@ -13986,9 +14042,9 @@ SWIGEXPORT void _wrap_TpetraCrsMatrix_insertGlobalValues(SwigClassWrapper const std::pair< SC const *,std::size_t > arg4 ; Teuchos::RCP< Tpetra::CrsMatrix< SC,LO,GO,NO > > *smartarg1 ; - smartarg1 = static_cast< Teuchos::RCP< Tpetra::CrsMatrix >* >(farg1->ptr); - arg1 = smartarg1 ? smartarg1->get() : NULL; - arg2 = *farg2; + smartarg1 = static_cast< Teuchos::RCP< Tpetra::CrsMatrix >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::CrsMatrix* >(smartarg1->get()) : NULL; + arg2 = static_cast< GO >(*farg2); (&arg3)->first = static_cast(farg3->data); (&arg3)->second = farg3->size; (&arg4)->first = static_cast(farg4->data); @@ -14027,8 +14083,8 @@ SWIGEXPORT void _wrap_TpetraCrsMatrix_insertLocalValues(SwigClassWrapper const * std::pair< SC const *,std::size_t > arg4 ; Teuchos::RCP< Tpetra::CrsMatrix< SC,LO,GO,NO > > *smartarg1 ; - smartarg1 = static_cast< Teuchos::RCP< Tpetra::CrsMatrix >* >(farg1->ptr); - arg1 = smartarg1 ? smartarg1->get() : NULL; + smartarg1 = static_cast< Teuchos::RCP< Tpetra::CrsMatrix >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::CrsMatrix* >(smartarg1->get()) : NULL; arg2 = *farg2 - 1; (&arg3)->first = static_cast(farg3->data); (&arg3)->second = farg3->size; @@ -14070,9 +14126,9 @@ SWIGEXPORT int _wrap_TpetraCrsMatrix_replaceGlobalValues(SwigClassWrapper const Teuchos::RCP< Tpetra::CrsMatrix< SC,LO,GO,NO > const > *smartarg1 ; LO result; - smartarg1 = static_cast< Teuchos::RCP >* >(farg1->ptr); - arg1 = smartarg1 ? const_cast*>(smartarg1->get()) : NULL; - arg2 = *farg2; + smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::CrsMatrix* >(smartarg1->get()) : NULL; + arg2 = static_cast< GO >(*farg2); (&arg3)->first = static_cast(farg3->data); (&arg3)->second = farg3->size; (&arg4)->first = static_cast(farg4->data); @@ -14100,7 +14156,7 @@ SWIGEXPORT int _wrap_TpetraCrsMatrix_replaceGlobalValues(SwigClassWrapper const SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::replaceGlobalValues(GO const,std::pair< GO const *,std::size_t >,std::pair< SC const *,std::size_t >) const", SWIG_UnknownError, "An unknown exception occurred", return 0); } } - fresult = result; + fresult = static_cast< LO >(result); return fresult; } @@ -14114,9 +14170,9 @@ SWIGEXPORT int _wrap_TpetraCrsMatrix_sumIntoGlobalValues(SwigClassWrapper const Teuchos::RCP< Tpetra::CrsMatrix< SC,LO,GO,NO > > *smartarg1 ; LO result; - smartarg1 = static_cast< Teuchos::RCP< Tpetra::CrsMatrix >* >(farg1->ptr); - arg1 = smartarg1 ? smartarg1->get() : NULL; - arg2 = *farg2; + smartarg1 = static_cast< Teuchos::RCP< Tpetra::CrsMatrix >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::CrsMatrix* >(smartarg1->get()) : NULL; + arg2 = static_cast< GO >(*farg2); (&arg3)->first = static_cast(farg3->data); (&arg3)->second = farg3->size; (&arg4)->first = static_cast(farg4->data); @@ -14144,7 +14200,7 @@ SWIGEXPORT int _wrap_TpetraCrsMatrix_sumIntoGlobalValues(SwigClassWrapper const SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::sumIntoGlobalValues(GO const,std::pair< GO const *,std::size_t >,std::pair< SC const *,std::size_t >)", SWIG_UnknownError, "An unknown exception occurred", return 0); } } - fresult = result; + fresult = static_cast< LO >(result); return fresult; } @@ -14156,8 +14212,8 @@ SWIGEXPORT void _wrap_TpetraCrsMatrix_setAllValues(SwigClassWrapper const *farg1 std::pair< SC *,std::size_t > arg4 ; Teuchos::RCP< Tpetra::CrsMatrix< SC,LO,GO,NO > > *smartarg1 ; - smartarg1 = static_cast< Teuchos::RCP< Tpetra::CrsMatrix >* >(farg1->ptr); - arg1 = smartarg1 ? smartarg1->get() : NULL; + smartarg1 = static_cast< Teuchos::RCP< Tpetra::CrsMatrix >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::CrsMatrix* >(smartarg1->get()) : NULL; (&arg2)->first = static_cast(farg2->data); (&arg2)->second = farg2->size; (&arg3)->first = static_cast(farg3->data); @@ -14198,8 +14254,8 @@ SWIGEXPORT void _wrap_TpetraCrsMatrix_getAllValues(SwigClassWrapper const *farg1 std::pair< SC *,std::size_t > arg4 ; Teuchos::RCP< Tpetra::CrsMatrix< SC,LO,GO,NO > const > *smartarg1 ; - smartarg1 = static_cast< Teuchos::RCP >* >(farg1->ptr); - arg1 = smartarg1 ? const_cast*>(smartarg1->get()) : NULL; + smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::CrsMatrix* >(smartarg1->get()) : NULL; (&arg2)->first = static_cast(farg2->data); (&arg2)->second = farg2->size; (&arg3)->first = static_cast(farg3->data); @@ -14241,9 +14297,9 @@ SWIGEXPORT void _wrap_TpetraCrsMatrix_getGlobalRowCopy(SwigClassWrapper const *f size_t *arg5 = 0 ; Teuchos::RCP< Tpetra::CrsMatrix< SC,LO,GO,NO > const > *smartarg1 ; - smartarg1 = static_cast< Teuchos::RCP >* >(farg1->ptr); - arg1 = smartarg1 ? const_cast*>(smartarg1->get()) : NULL; - arg2 = *farg2; + smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::CrsMatrix* >(smartarg1->get()) : NULL; + arg2 = static_cast< GO >(*farg2); (&arg3)->first = static_cast(farg3->data); (&arg3)->second = farg3->size; (&arg4)->first = static_cast(farg4->data); @@ -14284,8 +14340,8 @@ SWIGEXPORT void _wrap_TpetraCrsMatrix_getLocalRowCopy(SwigClassWrapper const *fa size_t *arg5 = 0 ; Teuchos::RCP< Tpetra::CrsMatrix< SC,LO,GO,NO > const > *smartarg1 ; - smartarg1 = static_cast< Teuchos::RCP >* >(farg1->ptr); - arg1 = smartarg1 ? const_cast*>(smartarg1->get()) : NULL; + smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::CrsMatrix* >(smartarg1->get()) : NULL; arg2 = *farg2 - 1; (&arg3)->first = static_cast(farg3->data); (&arg3)->second = farg3->size; @@ -14326,9 +14382,9 @@ SWIGEXPORT void _wrap_TpetraCrsMatrix_getGlobalRowView(SwigClassWrapper const *f std::pair< SC const *,std::size_t > arg4 ; Teuchos::RCP< Tpetra::CrsMatrix< SC,LO,GO,NO > const > *smartarg1 ; - smartarg1 = static_cast< Teuchos::RCP >* >(farg1->ptr); - arg1 = smartarg1 ? const_cast*>(smartarg1->get()) : NULL; - arg2 = *farg2; + smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::CrsMatrix* >(smartarg1->get()) : NULL; + arg2 = static_cast< GO >(*farg2); (&arg3)->first = static_cast(farg3->data); (&arg3)->second = farg3->size; (&arg4)->first = static_cast(farg4->data); @@ -14365,8 +14421,8 @@ SWIGEXPORT void _wrap_TpetraCrsMatrix_getLocalDiagOffsets(SwigClassWrapper const std::pair< std::size_t *,std::size_t > arg2 ; Teuchos::RCP< Tpetra::CrsMatrix< SC,LO,GO,NO > const > *smartarg1 ; - smartarg1 = static_cast< Teuchos::RCP >* >(farg1->ptr); - arg1 = smartarg1 ? const_cast*>(smartarg1->get()) : NULL; + smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::CrsMatrix* >(smartarg1->get()) : NULL; (&arg2)->first = static_cast(farg2->data); (&arg2)->second = farg2->size; { @@ -14405,14 +14461,14 @@ SWIGEXPORT void _wrap_TpetraCrsMatrix_doImport__SWIG_0(SwigClassWrapper const *f Teuchos::RCP< Tpetra::CrsMatrix< SC,LO,GO,NO > const > *smartarg2 ; Teuchos::RCP< Tpetra::Import< LO,GO,NO > const > *smartarg3 ; - smartarg1 = static_cast< Teuchos::RCP< Tpetra::CrsMatrix >* >(farg1->ptr); - arg1 = smartarg1 ? smartarg1->get() : NULL; + smartarg1 = static_cast< Teuchos::RCP< Tpetra::CrsMatrix >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::CrsMatrix* >(smartarg1->get()) : NULL; SWIG_check_sp_nonnull(farg2, "Tpetra::CrsMatrix< SC,LO,GO,NO > *", "TpetraCrsMatrix", "Tpetra::CrsMatrix< SC,LO,GO,NO >::doImport(Tpetra::CrsMatrix< SC,LO,GO,NO > const &,Tpetra::Import< LO,GO,NO > const &,Tpetra::CombineMode)", return ) - smartarg2 = static_cast< Teuchos::RCP >* >(farg2->ptr); - arg2 = const_cast*>(smartarg2->get()); + smartarg2 = static_cast< Teuchos::RCP >* >(farg2->cptr); + arg2 = const_cast< Tpetra::CrsMatrix* >(smartarg2->get()); SWIG_check_sp_nonnull(farg3, "Tpetra::Import< LO,GO,NO > *", "TpetraImport", "Tpetra::CrsMatrix< SC,LO,GO,NO >::doImport(Tpetra::CrsMatrix< SC,LO,GO,NO > const &,Tpetra::Import< LO,GO,NO > const &,Tpetra::CombineMode)", return ) - smartarg3 = static_cast< Teuchos::RCP >* >(farg3->ptr); - arg3 = const_cast*>(smartarg3->get()); + smartarg3 = static_cast< Teuchos::RCP >* >(farg3->cptr); + arg3 = const_cast< Tpetra::Import* >(smartarg3->get()); arg4 = static_cast< Tpetra::CombineMode >(*farg4); { // Make sure no unhandled exceptions exist before performing a new action @@ -14450,14 +14506,14 @@ SWIGEXPORT void _wrap_TpetraCrsMatrix_doImport__SWIG_1(SwigClassWrapper const *f Teuchos::RCP< Tpetra::CrsMatrix< SC,LO,GO,NO > const > *smartarg2 ; Teuchos::RCP< Tpetra::Export< LO,GO,NO > const > *smartarg3 ; - smartarg1 = static_cast< Teuchos::RCP< Tpetra::CrsMatrix >* >(farg1->ptr); - arg1 = smartarg1 ? smartarg1->get() : NULL; + smartarg1 = static_cast< Teuchos::RCP< Tpetra::CrsMatrix >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::CrsMatrix* >(smartarg1->get()) : NULL; SWIG_check_sp_nonnull(farg2, "Tpetra::CrsMatrix< SC,LO,GO,NO > *", "TpetraCrsMatrix", "Tpetra::CrsMatrix< SC,LO,GO,NO >::doImport(Tpetra::CrsMatrix< SC,LO,GO,NO > const &,Tpetra::Export< LO,GO,NO > const &,Tpetra::CombineMode)", return ) - smartarg2 = static_cast< Teuchos::RCP >* >(farg2->ptr); - arg2 = const_cast*>(smartarg2->get()); + smartarg2 = static_cast< Teuchos::RCP >* >(farg2->cptr); + arg2 = const_cast< Tpetra::CrsMatrix* >(smartarg2->get()); SWIG_check_sp_nonnull(farg3, "Tpetra::Export< LO,GO,NO > *", "TpetraExport", "Tpetra::CrsMatrix< SC,LO,GO,NO >::doImport(Tpetra::CrsMatrix< SC,LO,GO,NO > const &,Tpetra::Export< LO,GO,NO > const &,Tpetra::CombineMode)", return ) - smartarg3 = static_cast< Teuchos::RCP >* >(farg3->ptr); - arg3 = const_cast*>(smartarg3->get()); + smartarg3 = static_cast< Teuchos::RCP >* >(farg3->cptr); + arg3 = const_cast< Tpetra::Export* >(smartarg3->get()); arg4 = static_cast< Tpetra::CombineMode >(*farg4); { // Make sure no unhandled exceptions exist before performing a new action @@ -14495,14 +14551,14 @@ SWIGEXPORT void _wrap_TpetraCrsMatrix_doExport__SWIG_0(SwigClassWrapper const *f Teuchos::RCP< Tpetra::CrsMatrix< SC,LO,GO,NO > const > *smartarg2 ; Teuchos::RCP< Tpetra::Export< LO,GO,NO > const > *smartarg3 ; - smartarg1 = static_cast< Teuchos::RCP< Tpetra::CrsMatrix >* >(farg1->ptr); - arg1 = smartarg1 ? smartarg1->get() : NULL; + smartarg1 = static_cast< Teuchos::RCP< Tpetra::CrsMatrix >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::CrsMatrix* >(smartarg1->get()) : NULL; SWIG_check_sp_nonnull(farg2, "Tpetra::CrsMatrix< SC,LO,GO,NO > *", "TpetraCrsMatrix", "Tpetra::CrsMatrix< SC,LO,GO,NO >::doExport(Tpetra::CrsMatrix< SC,LO,GO,NO > const &,Tpetra::Export< LO,GO,NO > const &,Tpetra::CombineMode)", return ) - smartarg2 = static_cast< Teuchos::RCP >* >(farg2->ptr); - arg2 = const_cast*>(smartarg2->get()); + smartarg2 = static_cast< Teuchos::RCP >* >(farg2->cptr); + arg2 = const_cast< Tpetra::CrsMatrix* >(smartarg2->get()); SWIG_check_sp_nonnull(farg3, "Tpetra::Export< LO,GO,NO > *", "TpetraExport", "Tpetra::CrsMatrix< SC,LO,GO,NO >::doExport(Tpetra::CrsMatrix< SC,LO,GO,NO > const &,Tpetra::Export< LO,GO,NO > const &,Tpetra::CombineMode)", return ) - smartarg3 = static_cast< Teuchos::RCP >* >(farg3->ptr); - arg3 = const_cast*>(smartarg3->get()); + smartarg3 = static_cast< Teuchos::RCP >* >(farg3->cptr); + arg3 = const_cast< Tpetra::Export* >(smartarg3->get()); arg4 = static_cast< Tpetra::CombineMode >(*farg4); { // Make sure no unhandled exceptions exist before performing a new action @@ -14540,14 +14596,14 @@ SWIGEXPORT void _wrap_TpetraCrsMatrix_doExport__SWIG_1(SwigClassWrapper const *f Teuchos::RCP< Tpetra::CrsMatrix< SC,LO,GO,NO > const > *smartarg2 ; Teuchos::RCP< Tpetra::Import< LO,GO,NO > const > *smartarg3 ; - smartarg1 = static_cast< Teuchos::RCP< Tpetra::CrsMatrix >* >(farg1->ptr); - arg1 = smartarg1 ? smartarg1->get() : NULL; + smartarg1 = static_cast< Teuchos::RCP< Tpetra::CrsMatrix >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::CrsMatrix* >(smartarg1->get()) : NULL; SWIG_check_sp_nonnull(farg2, "Tpetra::CrsMatrix< SC,LO,GO,NO > *", "TpetraCrsMatrix", "Tpetra::CrsMatrix< SC,LO,GO,NO >::doExport(Tpetra::CrsMatrix< SC,LO,GO,NO > const &,Tpetra::Import< LO,GO,NO > const &,Tpetra::CombineMode)", return ) - smartarg2 = static_cast< Teuchos::RCP >* >(farg2->ptr); - arg2 = const_cast*>(smartarg2->get()); + smartarg2 = static_cast< Teuchos::RCP >* >(farg2->cptr); + arg2 = const_cast< Tpetra::CrsMatrix* >(smartarg2->get()); SWIG_check_sp_nonnull(farg3, "Tpetra::Import< LO,GO,NO > *", "TpetraImport", "Tpetra::CrsMatrix< SC,LO,GO,NO >::doExport(Tpetra::CrsMatrix< SC,LO,GO,NO > const &,Tpetra::Import< LO,GO,NO > const &,Tpetra::CombineMode)", return ) - smartarg3 = static_cast< Teuchos::RCP >* >(farg3->ptr); - arg3 = const_cast*>(smartarg3->get()); + smartarg3 = static_cast< Teuchos::RCP >* >(farg3->cptr); + arg3 = const_cast< Tpetra::Import* >(smartarg3->get()); arg4 = static_cast< Tpetra::CombineMode >(*farg4); { // Make sure no unhandled exceptions exist before performing a new action @@ -14577,7 +14633,7 @@ SWIGEXPORT void _wrap_TpetraCrsMatrix_doExport__SWIG_1(SwigClassWrapper const *f SWIGEXPORT void _wrap_assign_TpetraCrsMatrix(SwigClassWrapper * self, SwigClassWrapper const * other) { - typedef ::Teuchos::RCP< Tpetra::CrsMatrix > swig_lhs_classtype; + typedef Teuchos::RCP< Tpetra::CrsMatrix > swig_lhs_classtype; SWIG_assign(swig_lhs_classtype, self, swig_lhs_classtype, const_cast(other), 0 | swig::IS_DESTR); @@ -14589,7 +14645,7 @@ SWIGEXPORT SwigClassWrapper _wrap_operator_to_matrix(SwigClassWrapper const *far Teuchos::RCP< Tpetra::Operator< SC,LO,GO,NO > > arg1 ; Teuchos::RCP< Tpetra::CrsMatrix< SC,LO,GO,NO > > result; - if (farg1->ptr) arg1 = *static_cast< Teuchos::RCP< Tpetra::Operator >* >(farg1->ptr); + if (farg1->cptr) arg1 = *static_cast< Teuchos::RCP< Tpetra::Operator >* >(farg1->cptr); { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("ForTrilinos::operator_to_matrix< SC,LO,GO,NO >(Teuchos::RCP< Tpetra::Operator< SC,LO,GO,NO > >)");; @@ -14613,7 +14669,7 @@ SWIGEXPORT SwigClassWrapper _wrap_operator_to_matrix(SwigClassWrapper const *far SWIG_exception_impl("ForTrilinos::operator_to_matrix< SC,LO,GO,NO >(Teuchos::RCP< Tpetra::Operator< SC,LO,GO,NO > >)", SWIG_UnknownError, "An unknown exception occurred", return SwigClassWrapper_uninitialized()); } } - fresult.ptr = (new Teuchos::RCP< Tpetra::CrsMatrix >(static_cast< const Teuchos::RCP< Tpetra::CrsMatrix >& >(result))); + fresult.cptr = (new Teuchos::RCP< Tpetra::CrsMatrix >(static_cast< const Teuchos::RCP< Tpetra::CrsMatrix >& >(result))); fresult.mem = SWIG_MOVE; return fresult; } @@ -14624,7 +14680,7 @@ SWIGEXPORT SwigClassWrapper _wrap_matrix_to_operator(SwigClassWrapper const *far Teuchos::RCP< Tpetra::CrsMatrix< SC,LO,GO,NO > > arg1 ; Teuchos::RCP< Tpetra::Operator< SC,LO,GO,NO > > result; - if (farg1->ptr) arg1 = *static_cast< Teuchos::RCP< Tpetra::CrsMatrix >* >(farg1->ptr); + if (farg1->cptr) arg1 = *static_cast< Teuchos::RCP< Tpetra::CrsMatrix >* >(farg1->cptr); { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("ForTrilinos::matrix_to_operator< SC,LO,GO,NO >(Teuchos::RCP< Tpetra::CrsMatrix< SC,LO,GO,NO > >)");; @@ -14648,7 +14704,7 @@ SWIGEXPORT SwigClassWrapper _wrap_matrix_to_operator(SwigClassWrapper const *far SWIG_exception_impl("ForTrilinos::matrix_to_operator< SC,LO,GO,NO >(Teuchos::RCP< Tpetra::CrsMatrix< SC,LO,GO,NO > >)", SWIG_UnknownError, "An unknown exception occurred", return SwigClassWrapper_uninitialized()); } } - fresult.ptr = (new Teuchos::RCP< Tpetra::Operator >(static_cast< const Teuchos::RCP< Tpetra::Operator >& >(result))); + fresult.cptr = (new Teuchos::RCP< Tpetra::Operator >(static_cast< const Teuchos::RCP< Tpetra::Operator >& >(result))); fresult.mem = SWIG_MOVE; return fresult; } @@ -14667,10 +14723,10 @@ SWIGEXPORT SwigClassWrapper _wrap_TpetraReader_readSparseGraphFile__SWIG_0(SwigA tempstr1 = std::string(static_cast(farg1->data), farg1->size); arg1 = &tempstr1; - arg2 = farg2->ptr ? static_cast< Teuchos::RCP< Teuchos::Comm< int > const > * >(farg2->ptr) : &tempnull2; - arg3 = *farg3; - arg4 = *farg4; - arg5 = *farg5; + arg2 = farg2->cptr ? static_cast< Teuchos::RCP< Teuchos::Comm< int > const > * >(farg2->cptr) : &tempnull2; + arg3 = static_cast< bool >(*farg3); + arg4 = static_cast< bool >(*farg4); + arg5 = static_cast< bool >(*farg5); { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::MatrixMarket::Reader< CMT >::Tpetra_MatrixMarket_Reader_Sl_CMT_Sg__readSparseGraphFile__SWIG_0(std::string const &,Teuchos::RCP< Teuchos::Comm< int > const > const &,bool const,bool const,bool const)");; @@ -14694,7 +14750,7 @@ SWIGEXPORT SwigClassWrapper _wrap_TpetraReader_readSparseGraphFile__SWIG_0(SwigA SWIG_exception_impl("Tpetra::MatrixMarket::Reader< CMT >::Tpetra_MatrixMarket_Reader_Sl_CMT_Sg__readSparseGraphFile__SWIG_0(std::string const &,Teuchos::RCP< Teuchos::Comm< int > const > const &,bool const,bool const,bool const)", SWIG_UnknownError, "An unknown exception occurred", return SwigClassWrapper_uninitialized()); } } - fresult.ptr = (new Teuchos::RCP< Tpetra::CrsGraph >(static_cast< const Teuchos::RCP< Tpetra::CrsGraph >& >(result))); + fresult.cptr = (new Teuchos::RCP< Tpetra::CrsGraph >(static_cast< const Teuchos::RCP< Tpetra::CrsGraph >& >(result))); fresult.mem = SWIG_MOVE; return fresult; } @@ -14712,9 +14768,9 @@ SWIGEXPORT SwigClassWrapper _wrap_TpetraReader_readSparseGraphFile__SWIG_1(SwigA tempstr1 = std::string(static_cast(farg1->data), farg1->size); arg1 = &tempstr1; - arg2 = farg2->ptr ? static_cast< Teuchos::RCP< Teuchos::Comm< int > const > * >(farg2->ptr) : &tempnull2; - arg3 = *farg3; - arg4 = *farg4; + arg2 = farg2->cptr ? static_cast< Teuchos::RCP< Teuchos::Comm< int > const > * >(farg2->cptr) : &tempnull2; + arg3 = static_cast< bool >(*farg3); + arg4 = static_cast< bool >(*farg4); { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::MatrixMarket::Reader< CMT >::Tpetra_MatrixMarket_Reader_Sl_CMT_Sg__readSparseGraphFile__SWIG_0(std::string const &,Teuchos::RCP< Teuchos::Comm< int > const > const &,bool const,bool const)");; @@ -14738,7 +14794,7 @@ SWIGEXPORT SwigClassWrapper _wrap_TpetraReader_readSparseGraphFile__SWIG_1(SwigA SWIG_exception_impl("Tpetra::MatrixMarket::Reader< CMT >::Tpetra_MatrixMarket_Reader_Sl_CMT_Sg__readSparseGraphFile__SWIG_0(std::string const &,Teuchos::RCP< Teuchos::Comm< int > const > const &,bool const,bool const)", SWIG_UnknownError, "An unknown exception occurred", return SwigClassWrapper_uninitialized()); } } - fresult.ptr = (new Teuchos::RCP< Tpetra::CrsGraph >(static_cast< const Teuchos::RCP< Tpetra::CrsGraph >& >(result))); + fresult.cptr = (new Teuchos::RCP< Tpetra::CrsGraph >(static_cast< const Teuchos::RCP< Tpetra::CrsGraph >& >(result))); fresult.mem = SWIG_MOVE; return fresult; } @@ -14755,8 +14811,8 @@ SWIGEXPORT SwigClassWrapper _wrap_TpetraReader_readSparseGraphFile__SWIG_2(SwigA tempstr1 = std::string(static_cast(farg1->data), farg1->size); arg1 = &tempstr1; - arg2 = farg2->ptr ? static_cast< Teuchos::RCP< Teuchos::Comm< int > const > * >(farg2->ptr) : &tempnull2; - arg3 = *farg3; + arg2 = farg2->cptr ? static_cast< Teuchos::RCP< Teuchos::Comm< int > const > * >(farg2->cptr) : &tempnull2; + arg3 = static_cast< bool >(*farg3); { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::MatrixMarket::Reader< CMT >::Tpetra_MatrixMarket_Reader_Sl_CMT_Sg__readSparseGraphFile__SWIG_0(std::string const &,Teuchos::RCP< Teuchos::Comm< int > const > const &,bool const)");; @@ -14780,7 +14836,7 @@ SWIGEXPORT SwigClassWrapper _wrap_TpetraReader_readSparseGraphFile__SWIG_2(SwigA SWIG_exception_impl("Tpetra::MatrixMarket::Reader< CMT >::Tpetra_MatrixMarket_Reader_Sl_CMT_Sg__readSparseGraphFile__SWIG_0(std::string const &,Teuchos::RCP< Teuchos::Comm< int > const > const &,bool const)", SWIG_UnknownError, "An unknown exception occurred", return SwigClassWrapper_uninitialized()); } } - fresult.ptr = (new Teuchos::RCP< Tpetra::CrsGraph >(static_cast< const Teuchos::RCP< Tpetra::CrsGraph >& >(result))); + fresult.cptr = (new Teuchos::RCP< Tpetra::CrsGraph >(static_cast< const Teuchos::RCP< Tpetra::CrsGraph >& >(result))); fresult.mem = SWIG_MOVE; return fresult; } @@ -14796,7 +14852,7 @@ SWIGEXPORT SwigClassWrapper _wrap_TpetraReader_readSparseGraphFile__SWIG_3(SwigA tempstr1 = std::string(static_cast(farg1->data), farg1->size); arg1 = &tempstr1; - arg2 = farg2->ptr ? static_cast< Teuchos::RCP< Teuchos::Comm< int > const > * >(farg2->ptr) : &tempnull2; + arg2 = farg2->cptr ? static_cast< Teuchos::RCP< Teuchos::Comm< int > const > * >(farg2->cptr) : &tempnull2; { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::MatrixMarket::Reader< CMT >::Tpetra_MatrixMarket_Reader_Sl_CMT_Sg__readSparseGraphFile__SWIG_0(std::string const &,Teuchos::RCP< Teuchos::Comm< int > const > const &)");; @@ -14820,7 +14876,7 @@ SWIGEXPORT SwigClassWrapper _wrap_TpetraReader_readSparseGraphFile__SWIG_3(SwigA SWIG_exception_impl("Tpetra::MatrixMarket::Reader< CMT >::Tpetra_MatrixMarket_Reader_Sl_CMT_Sg__readSparseGraphFile__SWIG_0(std::string const &,Teuchos::RCP< Teuchos::Comm< int > const > const &)", SWIG_UnknownError, "An unknown exception occurred", return SwigClassWrapper_uninitialized()); } } - fresult.ptr = (new Teuchos::RCP< Tpetra::CrsGraph >(static_cast< const Teuchos::RCP< Tpetra::CrsGraph >& >(result))); + fresult.cptr = (new Teuchos::RCP< Tpetra::CrsGraph >(static_cast< const Teuchos::RCP< Tpetra::CrsGraph >& >(result))); fresult.mem = SWIG_MOVE; return fresult; } @@ -14842,11 +14898,11 @@ SWIGEXPORT SwigClassWrapper _wrap_TpetraReader_readSparseGraphFile__SWIG_4(SwigA tempstr1 = std::string(static_cast(farg1->data), farg1->size); arg1 = &tempstr1; - arg2 = farg2->ptr ? static_cast< Teuchos::RCP< Teuchos::Comm< int > const > * >(farg2->ptr) : &tempnull2; - arg3 = farg3->ptr ? static_cast< Teuchos::RCP< Teuchos::ParameterList > * >(farg3->ptr) : &tempnull3; - arg4 = farg4->ptr ? static_cast< Teuchos::RCP< Teuchos::ParameterList > * >(farg4->ptr) : &tempnull4; - arg5 = *farg5; - arg6 = *farg6; + arg2 = farg2->cptr ? static_cast< Teuchos::RCP< Teuchos::Comm< int > const > * >(farg2->cptr) : &tempnull2; + arg3 = farg3->cptr ? static_cast< Teuchos::RCP< Teuchos::ParameterList > * >(farg3->cptr) : &tempnull3; + arg4 = farg4->cptr ? static_cast< Teuchos::RCP< Teuchos::ParameterList > * >(farg4->cptr) : &tempnull4; + arg5 = static_cast< bool >(*farg5); + arg6 = static_cast< bool >(*farg6); { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::MatrixMarket::Reader< CMT >::Tpetra_MatrixMarket_Reader_Sl_CMT_Sg__readSparseGraphFile__SWIG_4(std::string const &,Teuchos::RCP< Teuchos::Comm< int > const > const &,Teuchos::RCP< Teuchos::ParameterList > const &,Teuchos::RCP< Teuchos::ParameterList > const &,bool const,bool const)");; @@ -14870,7 +14926,7 @@ SWIGEXPORT SwigClassWrapper _wrap_TpetraReader_readSparseGraphFile__SWIG_4(SwigA SWIG_exception_impl("Tpetra::MatrixMarket::Reader< CMT >::Tpetra_MatrixMarket_Reader_Sl_CMT_Sg__readSparseGraphFile__SWIG_4(std::string const &,Teuchos::RCP< Teuchos::Comm< int > const > const &,Teuchos::RCP< Teuchos::ParameterList > const &,Teuchos::RCP< Teuchos::ParameterList > const &,bool const,bool const)", SWIG_UnknownError, "An unknown exception occurred", return SwigClassWrapper_uninitialized()); } } - fresult.ptr = (new Teuchos::RCP< Tpetra::CrsGraph >(static_cast< const Teuchos::RCP< Tpetra::CrsGraph >& >(result))); + fresult.cptr = (new Teuchos::RCP< Tpetra::CrsGraph >(static_cast< const Teuchos::RCP< Tpetra::CrsGraph >& >(result))); fresult.mem = SWIG_MOVE; return fresult; } @@ -14891,10 +14947,10 @@ SWIGEXPORT SwigClassWrapper _wrap_TpetraReader_readSparseGraphFile__SWIG_5(SwigA tempstr1 = std::string(static_cast(farg1->data), farg1->size); arg1 = &tempstr1; - arg2 = farg2->ptr ? static_cast< Teuchos::RCP< Teuchos::Comm< int > const > * >(farg2->ptr) : &tempnull2; - arg3 = farg3->ptr ? static_cast< Teuchos::RCP< Teuchos::ParameterList > * >(farg3->ptr) : &tempnull3; - arg4 = farg4->ptr ? static_cast< Teuchos::RCP< Teuchos::ParameterList > * >(farg4->ptr) : &tempnull4; - arg5 = *farg5; + arg2 = farg2->cptr ? static_cast< Teuchos::RCP< Teuchos::Comm< int > const > * >(farg2->cptr) : &tempnull2; + arg3 = farg3->cptr ? static_cast< Teuchos::RCP< Teuchos::ParameterList > * >(farg3->cptr) : &tempnull3; + arg4 = farg4->cptr ? static_cast< Teuchos::RCP< Teuchos::ParameterList > * >(farg4->cptr) : &tempnull4; + arg5 = static_cast< bool >(*farg5); { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::MatrixMarket::Reader< CMT >::Tpetra_MatrixMarket_Reader_Sl_CMT_Sg__readSparseGraphFile__SWIG_4(std::string const &,Teuchos::RCP< Teuchos::Comm< int > const > const &,Teuchos::RCP< Teuchos::ParameterList > const &,Teuchos::RCP< Teuchos::ParameterList > const &,bool const)");; @@ -14918,7 +14974,7 @@ SWIGEXPORT SwigClassWrapper _wrap_TpetraReader_readSparseGraphFile__SWIG_5(SwigA SWIG_exception_impl("Tpetra::MatrixMarket::Reader< CMT >::Tpetra_MatrixMarket_Reader_Sl_CMT_Sg__readSparseGraphFile__SWIG_4(std::string const &,Teuchos::RCP< Teuchos::Comm< int > const > const &,Teuchos::RCP< Teuchos::ParameterList > const &,Teuchos::RCP< Teuchos::ParameterList > const &,bool const)", SWIG_UnknownError, "An unknown exception occurred", return SwigClassWrapper_uninitialized()); } } - fresult.ptr = (new Teuchos::RCP< Tpetra::CrsGraph >(static_cast< const Teuchos::RCP< Tpetra::CrsGraph >& >(result))); + fresult.cptr = (new Teuchos::RCP< Tpetra::CrsGraph >(static_cast< const Teuchos::RCP< Tpetra::CrsGraph >& >(result))); fresult.mem = SWIG_MOVE; return fresult; } @@ -14938,9 +14994,9 @@ SWIGEXPORT SwigClassWrapper _wrap_TpetraReader_readSparseGraphFile__SWIG_6(SwigA tempstr1 = std::string(static_cast(farg1->data), farg1->size); arg1 = &tempstr1; - arg2 = farg2->ptr ? static_cast< Teuchos::RCP< Teuchos::Comm< int > const > * >(farg2->ptr) : &tempnull2; - arg3 = farg3->ptr ? static_cast< Teuchos::RCP< Teuchos::ParameterList > * >(farg3->ptr) : &tempnull3; - arg4 = farg4->ptr ? static_cast< Teuchos::RCP< Teuchos::ParameterList > * >(farg4->ptr) : &tempnull4; + arg2 = farg2->cptr ? static_cast< Teuchos::RCP< Teuchos::Comm< int > const > * >(farg2->cptr) : &tempnull2; + arg3 = farg3->cptr ? static_cast< Teuchos::RCP< Teuchos::ParameterList > * >(farg3->cptr) : &tempnull3; + arg4 = farg4->cptr ? static_cast< Teuchos::RCP< Teuchos::ParameterList > * >(farg4->cptr) : &tempnull4; { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::MatrixMarket::Reader< CMT >::Tpetra_MatrixMarket_Reader_Sl_CMT_Sg__readSparseGraphFile__SWIG_4(std::string const &,Teuchos::RCP< Teuchos::Comm< int > const > const &,Teuchos::RCP< Teuchos::ParameterList > const &,Teuchos::RCP< Teuchos::ParameterList > const &)");; @@ -14964,7 +15020,7 @@ SWIGEXPORT SwigClassWrapper _wrap_TpetraReader_readSparseGraphFile__SWIG_6(SwigA SWIG_exception_impl("Tpetra::MatrixMarket::Reader< CMT >::Tpetra_MatrixMarket_Reader_Sl_CMT_Sg__readSparseGraphFile__SWIG_4(std::string const &,Teuchos::RCP< Teuchos::Comm< int > const > const &,Teuchos::RCP< Teuchos::ParameterList > const &,Teuchos::RCP< Teuchos::ParameterList > const &)", SWIG_UnknownError, "An unknown exception occurred", return SwigClassWrapper_uninitialized()); } } - fresult.ptr = (new Teuchos::RCP< Tpetra::CrsGraph >(static_cast< const Teuchos::RCP< Tpetra::CrsGraph >& >(result))); + fresult.cptr = (new Teuchos::RCP< Tpetra::CrsGraph >(static_cast< const Teuchos::RCP< Tpetra::CrsGraph >& >(result))); fresult.mem = SWIG_MOVE; return fresult; } @@ -14989,13 +15045,13 @@ SWIGEXPORT SwigClassWrapper _wrap_TpetraReader_readSparseGraphFile__SWIG_7(SwigA tempstr1 = std::string(static_cast(farg1->data), farg1->size); arg1 = &tempstr1; - arg2 = farg2->ptr ? static_cast< Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > * >(farg2->ptr) : &tempnull2; - arg3 = farg3->ptr ? static_cast< Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > * >(farg3->ptr) : &tempnull3; - arg4 = farg4->ptr ? static_cast< Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > * >(farg4->ptr) : &tempnull4; - arg5 = farg5->ptr ? static_cast< Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > * >(farg5->ptr) : &tempnull5; - arg6 = *farg6; - arg7 = *farg7; - arg8 = *farg8; + arg2 = farg2->cptr ? static_cast< Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > * >(farg2->cptr) : &tempnull2; + arg3 = farg3->cptr ? static_cast< Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > * >(farg3->cptr) : &tempnull3; + arg4 = farg4->cptr ? static_cast< Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > * >(farg4->cptr) : &tempnull4; + arg5 = farg5->cptr ? static_cast< Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > * >(farg5->cptr) : &tempnull5; + arg6 = static_cast< bool >(*farg6); + arg7 = static_cast< bool >(*farg7); + arg8 = static_cast< bool >(*farg8); { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::MatrixMarket::Reader< CMT >::Tpetra_MatrixMarket_Reader_Sl_CMT_Sg__readSparseGraphFile__SWIG_7(std::string const &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > const &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > const &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > const &,bool const,bool const,bool const)");; @@ -15019,7 +15075,7 @@ SWIGEXPORT SwigClassWrapper _wrap_TpetraReader_readSparseGraphFile__SWIG_7(SwigA SWIG_exception_impl("Tpetra::MatrixMarket::Reader< CMT >::Tpetra_MatrixMarket_Reader_Sl_CMT_Sg__readSparseGraphFile__SWIG_7(std::string const &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > const &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > const &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > const &,bool const,bool const,bool const)", SWIG_UnknownError, "An unknown exception occurred", return SwigClassWrapper_uninitialized()); } } - fresult.ptr = (new Teuchos::RCP< Tpetra::CrsGraph >(static_cast< const Teuchos::RCP< Tpetra::CrsGraph >& >(result))); + fresult.cptr = (new Teuchos::RCP< Tpetra::CrsGraph >(static_cast< const Teuchos::RCP< Tpetra::CrsGraph >& >(result))); fresult.mem = SWIG_MOVE; return fresult; } @@ -15043,12 +15099,12 @@ SWIGEXPORT SwigClassWrapper _wrap_TpetraReader_readSparseGraphFile__SWIG_8(SwigA tempstr1 = std::string(static_cast(farg1->data), farg1->size); arg1 = &tempstr1; - arg2 = farg2->ptr ? static_cast< Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > * >(farg2->ptr) : &tempnull2; - arg3 = farg3->ptr ? static_cast< Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > * >(farg3->ptr) : &tempnull3; - arg4 = farg4->ptr ? static_cast< Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > * >(farg4->ptr) : &tempnull4; - arg5 = farg5->ptr ? static_cast< Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > * >(farg5->ptr) : &tempnull5; - arg6 = *farg6; - arg7 = *farg7; + arg2 = farg2->cptr ? static_cast< Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > * >(farg2->cptr) : &tempnull2; + arg3 = farg3->cptr ? static_cast< Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > * >(farg3->cptr) : &tempnull3; + arg4 = farg4->cptr ? static_cast< Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > * >(farg4->cptr) : &tempnull4; + arg5 = farg5->cptr ? static_cast< Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > * >(farg5->cptr) : &tempnull5; + arg6 = static_cast< bool >(*farg6); + arg7 = static_cast< bool >(*farg7); { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::MatrixMarket::Reader< CMT >::Tpetra_MatrixMarket_Reader_Sl_CMT_Sg__readSparseGraphFile__SWIG_7(std::string const &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > const &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > const &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > const &,bool const,bool const)");; @@ -15072,7 +15128,7 @@ SWIGEXPORT SwigClassWrapper _wrap_TpetraReader_readSparseGraphFile__SWIG_8(SwigA SWIG_exception_impl("Tpetra::MatrixMarket::Reader< CMT >::Tpetra_MatrixMarket_Reader_Sl_CMT_Sg__readSparseGraphFile__SWIG_7(std::string const &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > const &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > const &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > const &,bool const,bool const)", SWIG_UnknownError, "An unknown exception occurred", return SwigClassWrapper_uninitialized()); } } - fresult.ptr = (new Teuchos::RCP< Tpetra::CrsGraph >(static_cast< const Teuchos::RCP< Tpetra::CrsGraph >& >(result))); + fresult.cptr = (new Teuchos::RCP< Tpetra::CrsGraph >(static_cast< const Teuchos::RCP< Tpetra::CrsGraph >& >(result))); fresult.mem = SWIG_MOVE; return fresult; } @@ -15095,11 +15151,11 @@ SWIGEXPORT SwigClassWrapper _wrap_TpetraReader_readSparseGraphFile__SWIG_9(SwigA tempstr1 = std::string(static_cast(farg1->data), farg1->size); arg1 = &tempstr1; - arg2 = farg2->ptr ? static_cast< Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > * >(farg2->ptr) : &tempnull2; - arg3 = farg3->ptr ? static_cast< Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > * >(farg3->ptr) : &tempnull3; - arg4 = farg4->ptr ? static_cast< Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > * >(farg4->ptr) : &tempnull4; - arg5 = farg5->ptr ? static_cast< Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > * >(farg5->ptr) : &tempnull5; - arg6 = *farg6; + arg2 = farg2->cptr ? static_cast< Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > * >(farg2->cptr) : &tempnull2; + arg3 = farg3->cptr ? static_cast< Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > * >(farg3->cptr) : &tempnull3; + arg4 = farg4->cptr ? static_cast< Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > * >(farg4->cptr) : &tempnull4; + arg5 = farg5->cptr ? static_cast< Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > * >(farg5->cptr) : &tempnull5; + arg6 = static_cast< bool >(*farg6); { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::MatrixMarket::Reader< CMT >::Tpetra_MatrixMarket_Reader_Sl_CMT_Sg__readSparseGraphFile__SWIG_7(std::string const &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > const &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > const &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > const &,bool const)");; @@ -15123,7 +15179,7 @@ SWIGEXPORT SwigClassWrapper _wrap_TpetraReader_readSparseGraphFile__SWIG_9(SwigA SWIG_exception_impl("Tpetra::MatrixMarket::Reader< CMT >::Tpetra_MatrixMarket_Reader_Sl_CMT_Sg__readSparseGraphFile__SWIG_7(std::string const &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > const &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > const &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > const &,bool const)", SWIG_UnknownError, "An unknown exception occurred", return SwigClassWrapper_uninitialized()); } } - fresult.ptr = (new Teuchos::RCP< Tpetra::CrsGraph >(static_cast< const Teuchos::RCP< Tpetra::CrsGraph >& >(result))); + fresult.cptr = (new Teuchos::RCP< Tpetra::CrsGraph >(static_cast< const Teuchos::RCP< Tpetra::CrsGraph >& >(result))); fresult.mem = SWIG_MOVE; return fresult; } @@ -15145,10 +15201,10 @@ SWIGEXPORT SwigClassWrapper _wrap_TpetraReader_readSparseGraphFile__SWIG_10(Swig tempstr1 = std::string(static_cast(farg1->data), farg1->size); arg1 = &tempstr1; - arg2 = farg2->ptr ? static_cast< Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > * >(farg2->ptr) : &tempnull2; - arg3 = farg3->ptr ? static_cast< Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > * >(farg3->ptr) : &tempnull3; - arg4 = farg4->ptr ? static_cast< Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > * >(farg4->ptr) : &tempnull4; - arg5 = farg5->ptr ? static_cast< Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > * >(farg5->ptr) : &tempnull5; + arg2 = farg2->cptr ? static_cast< Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > * >(farg2->cptr) : &tempnull2; + arg3 = farg3->cptr ? static_cast< Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > * >(farg3->cptr) : &tempnull3; + arg4 = farg4->cptr ? static_cast< Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > * >(farg4->cptr) : &tempnull4; + arg5 = farg5->cptr ? static_cast< Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > * >(farg5->cptr) : &tempnull5; { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::MatrixMarket::Reader< CMT >::Tpetra_MatrixMarket_Reader_Sl_CMT_Sg__readSparseGraphFile__SWIG_7(std::string const &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > const &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > const &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > const &)");; @@ -15172,7 +15228,7 @@ SWIGEXPORT SwigClassWrapper _wrap_TpetraReader_readSparseGraphFile__SWIG_10(Swig SWIG_exception_impl("Tpetra::MatrixMarket::Reader< CMT >::Tpetra_MatrixMarket_Reader_Sl_CMT_Sg__readSparseGraphFile__SWIG_7(std::string const &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > const &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > const &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > const &)", SWIG_UnknownError, "An unknown exception occurred", return SwigClassWrapper_uninitialized()); } } - fresult.ptr = (new Teuchos::RCP< Tpetra::CrsGraph >(static_cast< const Teuchos::RCP< Tpetra::CrsGraph >& >(result))); + fresult.cptr = (new Teuchos::RCP< Tpetra::CrsGraph >(static_cast< const Teuchos::RCP< Tpetra::CrsGraph >& >(result))); fresult.mem = SWIG_MOVE; return fresult; } @@ -15191,10 +15247,10 @@ SWIGEXPORT SwigClassWrapper _wrap_TpetraReader_readSparseFile__SWIG_0(SwigArrayW tempstr1 = std::string(static_cast(farg1->data), farg1->size); arg1 = &tempstr1; - arg2 = farg2->ptr ? static_cast< Teuchos::RCP< Teuchos::Comm< int > const > * >(farg2->ptr) : &tempnull2; - arg3 = *farg3; - arg4 = *farg4; - arg5 = *farg5; + arg2 = farg2->cptr ? static_cast< Teuchos::RCP< Teuchos::Comm< int > const > * >(farg2->cptr) : &tempnull2; + arg3 = static_cast< bool >(*farg3); + arg4 = static_cast< bool >(*farg4); + arg5 = static_cast< bool >(*farg5); { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::MatrixMarket::Reader< CMT >::Tpetra_MatrixMarket_Reader_Sl_CMT_Sg__readSparseFile__SWIG_0(std::string const &,Teuchos::RCP< Teuchos::Comm< int > const > const &,bool const,bool const,bool const)");; @@ -15218,7 +15274,7 @@ SWIGEXPORT SwigClassWrapper _wrap_TpetraReader_readSparseFile__SWIG_0(SwigArrayW SWIG_exception_impl("Tpetra::MatrixMarket::Reader< CMT >::Tpetra_MatrixMarket_Reader_Sl_CMT_Sg__readSparseFile__SWIG_0(std::string const &,Teuchos::RCP< Teuchos::Comm< int > const > const &,bool const,bool const,bool const)", SWIG_UnknownError, "An unknown exception occurred", return SwigClassWrapper_uninitialized()); } } - fresult.ptr = (new Teuchos::RCP< Tpetra::CrsMatrix >(static_cast< const Teuchos::RCP< Tpetra::CrsMatrix >& >(result))); + fresult.cptr = (new Teuchos::RCP< Tpetra::CrsMatrix >(static_cast< const Teuchos::RCP< Tpetra::CrsMatrix >& >(result))); fresult.mem = SWIG_MOVE; return fresult; } @@ -15236,9 +15292,9 @@ SWIGEXPORT SwigClassWrapper _wrap_TpetraReader_readSparseFile__SWIG_1(SwigArrayW tempstr1 = std::string(static_cast(farg1->data), farg1->size); arg1 = &tempstr1; - arg2 = farg2->ptr ? static_cast< Teuchos::RCP< Teuchos::Comm< int > const > * >(farg2->ptr) : &tempnull2; - arg3 = *farg3; - arg4 = *farg4; + arg2 = farg2->cptr ? static_cast< Teuchos::RCP< Teuchos::Comm< int > const > * >(farg2->cptr) : &tempnull2; + arg3 = static_cast< bool >(*farg3); + arg4 = static_cast< bool >(*farg4); { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::MatrixMarket::Reader< CMT >::Tpetra_MatrixMarket_Reader_Sl_CMT_Sg__readSparseFile__SWIG_0(std::string const &,Teuchos::RCP< Teuchos::Comm< int > const > const &,bool const,bool const)");; @@ -15262,7 +15318,7 @@ SWIGEXPORT SwigClassWrapper _wrap_TpetraReader_readSparseFile__SWIG_1(SwigArrayW SWIG_exception_impl("Tpetra::MatrixMarket::Reader< CMT >::Tpetra_MatrixMarket_Reader_Sl_CMT_Sg__readSparseFile__SWIG_0(std::string const &,Teuchos::RCP< Teuchos::Comm< int > const > const &,bool const,bool const)", SWIG_UnknownError, "An unknown exception occurred", return SwigClassWrapper_uninitialized()); } } - fresult.ptr = (new Teuchos::RCP< Tpetra::CrsMatrix >(static_cast< const Teuchos::RCP< Tpetra::CrsMatrix >& >(result))); + fresult.cptr = (new Teuchos::RCP< Tpetra::CrsMatrix >(static_cast< const Teuchos::RCP< Tpetra::CrsMatrix >& >(result))); fresult.mem = SWIG_MOVE; return fresult; } @@ -15279,8 +15335,8 @@ SWIGEXPORT SwigClassWrapper _wrap_TpetraReader_readSparseFile__SWIG_2(SwigArrayW tempstr1 = std::string(static_cast(farg1->data), farg1->size); arg1 = &tempstr1; - arg2 = farg2->ptr ? static_cast< Teuchos::RCP< Teuchos::Comm< int > const > * >(farg2->ptr) : &tempnull2; - arg3 = *farg3; + arg2 = farg2->cptr ? static_cast< Teuchos::RCP< Teuchos::Comm< int > const > * >(farg2->cptr) : &tempnull2; + arg3 = static_cast< bool >(*farg3); { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::MatrixMarket::Reader< CMT >::Tpetra_MatrixMarket_Reader_Sl_CMT_Sg__readSparseFile__SWIG_0(std::string const &,Teuchos::RCP< Teuchos::Comm< int > const > const &,bool const)");; @@ -15304,7 +15360,7 @@ SWIGEXPORT SwigClassWrapper _wrap_TpetraReader_readSparseFile__SWIG_2(SwigArrayW SWIG_exception_impl("Tpetra::MatrixMarket::Reader< CMT >::Tpetra_MatrixMarket_Reader_Sl_CMT_Sg__readSparseFile__SWIG_0(std::string const &,Teuchos::RCP< Teuchos::Comm< int > const > const &,bool const)", SWIG_UnknownError, "An unknown exception occurred", return SwigClassWrapper_uninitialized()); } } - fresult.ptr = (new Teuchos::RCP< Tpetra::CrsMatrix >(static_cast< const Teuchos::RCP< Tpetra::CrsMatrix >& >(result))); + fresult.cptr = (new Teuchos::RCP< Tpetra::CrsMatrix >(static_cast< const Teuchos::RCP< Tpetra::CrsMatrix >& >(result))); fresult.mem = SWIG_MOVE; return fresult; } @@ -15320,7 +15376,7 @@ SWIGEXPORT SwigClassWrapper _wrap_TpetraReader_readSparseFile__SWIG_3(SwigArrayW tempstr1 = std::string(static_cast(farg1->data), farg1->size); arg1 = &tempstr1; - arg2 = farg2->ptr ? static_cast< Teuchos::RCP< Teuchos::Comm< int > const > * >(farg2->ptr) : &tempnull2; + arg2 = farg2->cptr ? static_cast< Teuchos::RCP< Teuchos::Comm< int > const > * >(farg2->cptr) : &tempnull2; { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::MatrixMarket::Reader< CMT >::Tpetra_MatrixMarket_Reader_Sl_CMT_Sg__readSparseFile__SWIG_0(std::string const &,Teuchos::RCP< Teuchos::Comm< int > const > const &)");; @@ -15344,7 +15400,7 @@ SWIGEXPORT SwigClassWrapper _wrap_TpetraReader_readSparseFile__SWIG_3(SwigArrayW SWIG_exception_impl("Tpetra::MatrixMarket::Reader< CMT >::Tpetra_MatrixMarket_Reader_Sl_CMT_Sg__readSparseFile__SWIG_0(std::string const &,Teuchos::RCP< Teuchos::Comm< int > const > const &)", SWIG_UnknownError, "An unknown exception occurred", return SwigClassWrapper_uninitialized()); } } - fresult.ptr = (new Teuchos::RCP< Tpetra::CrsMatrix >(static_cast< const Teuchos::RCP< Tpetra::CrsMatrix >& >(result))); + fresult.cptr = (new Teuchos::RCP< Tpetra::CrsMatrix >(static_cast< const Teuchos::RCP< Tpetra::CrsMatrix >& >(result))); fresult.mem = SWIG_MOVE; return fresult; } @@ -15366,11 +15422,11 @@ SWIGEXPORT SwigClassWrapper _wrap_TpetraReader_readSparseFile__SWIG_4(SwigArrayW tempstr1 = std::string(static_cast(farg1->data), farg1->size); arg1 = &tempstr1; - arg2 = farg2->ptr ? static_cast< Teuchos::RCP< Teuchos::Comm< int > const > * >(farg2->ptr) : &tempnull2; - arg3 = farg3->ptr ? static_cast< Teuchos::RCP< Teuchos::ParameterList > * >(farg3->ptr) : &tempnull3; - arg4 = farg4->ptr ? static_cast< Teuchos::RCP< Teuchos::ParameterList > * >(farg4->ptr) : &tempnull4; - arg5 = *farg5; - arg6 = *farg6; + arg2 = farg2->cptr ? static_cast< Teuchos::RCP< Teuchos::Comm< int > const > * >(farg2->cptr) : &tempnull2; + arg3 = farg3->cptr ? static_cast< Teuchos::RCP< Teuchos::ParameterList > * >(farg3->cptr) : &tempnull3; + arg4 = farg4->cptr ? static_cast< Teuchos::RCP< Teuchos::ParameterList > * >(farg4->cptr) : &tempnull4; + arg5 = static_cast< bool >(*farg5); + arg6 = static_cast< bool >(*farg6); { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::MatrixMarket::Reader< CMT >::Tpetra_MatrixMarket_Reader_Sl_CMT_Sg__readSparseFile__SWIG_4(std::string const &,Teuchos::RCP< Teuchos::Comm< int > const > const &,Teuchos::RCP< Teuchos::ParameterList > const &,Teuchos::RCP< Teuchos::ParameterList > const &,bool const,bool const)");; @@ -15394,7 +15450,7 @@ SWIGEXPORT SwigClassWrapper _wrap_TpetraReader_readSparseFile__SWIG_4(SwigArrayW SWIG_exception_impl("Tpetra::MatrixMarket::Reader< CMT >::Tpetra_MatrixMarket_Reader_Sl_CMT_Sg__readSparseFile__SWIG_4(std::string const &,Teuchos::RCP< Teuchos::Comm< int > const > const &,Teuchos::RCP< Teuchos::ParameterList > const &,Teuchos::RCP< Teuchos::ParameterList > const &,bool const,bool const)", SWIG_UnknownError, "An unknown exception occurred", return SwigClassWrapper_uninitialized()); } } - fresult.ptr = (new Teuchos::RCP< Tpetra::CrsMatrix >(static_cast< const Teuchos::RCP< Tpetra::CrsMatrix >& >(result))); + fresult.cptr = (new Teuchos::RCP< Tpetra::CrsMatrix >(static_cast< const Teuchos::RCP< Tpetra::CrsMatrix >& >(result))); fresult.mem = SWIG_MOVE; return fresult; } @@ -15415,10 +15471,10 @@ SWIGEXPORT SwigClassWrapper _wrap_TpetraReader_readSparseFile__SWIG_5(SwigArrayW tempstr1 = std::string(static_cast(farg1->data), farg1->size); arg1 = &tempstr1; - arg2 = farg2->ptr ? static_cast< Teuchos::RCP< Teuchos::Comm< int > const > * >(farg2->ptr) : &tempnull2; - arg3 = farg3->ptr ? static_cast< Teuchos::RCP< Teuchos::ParameterList > * >(farg3->ptr) : &tempnull3; - arg4 = farg4->ptr ? static_cast< Teuchos::RCP< Teuchos::ParameterList > * >(farg4->ptr) : &tempnull4; - arg5 = *farg5; + arg2 = farg2->cptr ? static_cast< Teuchos::RCP< Teuchos::Comm< int > const > * >(farg2->cptr) : &tempnull2; + arg3 = farg3->cptr ? static_cast< Teuchos::RCP< Teuchos::ParameterList > * >(farg3->cptr) : &tempnull3; + arg4 = farg4->cptr ? static_cast< Teuchos::RCP< Teuchos::ParameterList > * >(farg4->cptr) : &tempnull4; + arg5 = static_cast< bool >(*farg5); { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::MatrixMarket::Reader< CMT >::Tpetra_MatrixMarket_Reader_Sl_CMT_Sg__readSparseFile__SWIG_4(std::string const &,Teuchos::RCP< Teuchos::Comm< int > const > const &,Teuchos::RCP< Teuchos::ParameterList > const &,Teuchos::RCP< Teuchos::ParameterList > const &,bool const)");; @@ -15442,7 +15498,7 @@ SWIGEXPORT SwigClassWrapper _wrap_TpetraReader_readSparseFile__SWIG_5(SwigArrayW SWIG_exception_impl("Tpetra::MatrixMarket::Reader< CMT >::Tpetra_MatrixMarket_Reader_Sl_CMT_Sg__readSparseFile__SWIG_4(std::string const &,Teuchos::RCP< Teuchos::Comm< int > const > const &,Teuchos::RCP< Teuchos::ParameterList > const &,Teuchos::RCP< Teuchos::ParameterList > const &,bool const)", SWIG_UnknownError, "An unknown exception occurred", return SwigClassWrapper_uninitialized()); } } - fresult.ptr = (new Teuchos::RCP< Tpetra::CrsMatrix >(static_cast< const Teuchos::RCP< Tpetra::CrsMatrix >& >(result))); + fresult.cptr = (new Teuchos::RCP< Tpetra::CrsMatrix >(static_cast< const Teuchos::RCP< Tpetra::CrsMatrix >& >(result))); fresult.mem = SWIG_MOVE; return fresult; } @@ -15462,9 +15518,9 @@ SWIGEXPORT SwigClassWrapper _wrap_TpetraReader_readSparseFile__SWIG_6(SwigArrayW tempstr1 = std::string(static_cast(farg1->data), farg1->size); arg1 = &tempstr1; - arg2 = farg2->ptr ? static_cast< Teuchos::RCP< Teuchos::Comm< int > const > * >(farg2->ptr) : &tempnull2; - arg3 = farg3->ptr ? static_cast< Teuchos::RCP< Teuchos::ParameterList > * >(farg3->ptr) : &tempnull3; - arg4 = farg4->ptr ? static_cast< Teuchos::RCP< Teuchos::ParameterList > * >(farg4->ptr) : &tempnull4; + arg2 = farg2->cptr ? static_cast< Teuchos::RCP< Teuchos::Comm< int > const > * >(farg2->cptr) : &tempnull2; + arg3 = farg3->cptr ? static_cast< Teuchos::RCP< Teuchos::ParameterList > * >(farg3->cptr) : &tempnull3; + arg4 = farg4->cptr ? static_cast< Teuchos::RCP< Teuchos::ParameterList > * >(farg4->cptr) : &tempnull4; { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::MatrixMarket::Reader< CMT >::Tpetra_MatrixMarket_Reader_Sl_CMT_Sg__readSparseFile__SWIG_4(std::string const &,Teuchos::RCP< Teuchos::Comm< int > const > const &,Teuchos::RCP< Teuchos::ParameterList > const &,Teuchos::RCP< Teuchos::ParameterList > const &)");; @@ -15488,7 +15544,7 @@ SWIGEXPORT SwigClassWrapper _wrap_TpetraReader_readSparseFile__SWIG_6(SwigArrayW SWIG_exception_impl("Tpetra::MatrixMarket::Reader< CMT >::Tpetra_MatrixMarket_Reader_Sl_CMT_Sg__readSparseFile__SWIG_4(std::string const &,Teuchos::RCP< Teuchos::Comm< int > const > const &,Teuchos::RCP< Teuchos::ParameterList > const &,Teuchos::RCP< Teuchos::ParameterList > const &)", SWIG_UnknownError, "An unknown exception occurred", return SwigClassWrapper_uninitialized()); } } - fresult.ptr = (new Teuchos::RCP< Tpetra::CrsMatrix >(static_cast< const Teuchos::RCP< Tpetra::CrsMatrix >& >(result))); + fresult.cptr = (new Teuchos::RCP< Tpetra::CrsMatrix >(static_cast< const Teuchos::RCP< Tpetra::CrsMatrix >& >(result))); fresult.mem = SWIG_MOVE; return fresult; } @@ -15513,13 +15569,13 @@ SWIGEXPORT SwigClassWrapper _wrap_TpetraReader_readSparseFile__SWIG_7(SwigArrayW tempstr1 = std::string(static_cast(farg1->data), farg1->size); arg1 = &tempstr1; - arg2 = farg2->ptr ? static_cast< Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > * >(farg2->ptr) : &tempnull2; - arg3 = farg3->ptr ? static_cast< Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > * >(farg3->ptr) : &tempnull3; - arg4 = farg4->ptr ? static_cast< Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > * >(farg4->ptr) : &tempnull4; - arg5 = farg5->ptr ? static_cast< Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > * >(farg5->ptr) : &tempnull5; - arg6 = *farg6; - arg7 = *farg7; - arg8 = *farg8; + arg2 = farg2->cptr ? static_cast< Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > * >(farg2->cptr) : &tempnull2; + arg3 = farg3->cptr ? static_cast< Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > * >(farg3->cptr) : &tempnull3; + arg4 = farg4->cptr ? static_cast< Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > * >(farg4->cptr) : &tempnull4; + arg5 = farg5->cptr ? static_cast< Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > * >(farg5->cptr) : &tempnull5; + arg6 = static_cast< bool >(*farg6); + arg7 = static_cast< bool >(*farg7); + arg8 = static_cast< bool >(*farg8); { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::MatrixMarket::Reader< CMT >::Tpetra_MatrixMarket_Reader_Sl_CMT_Sg__readSparseFile__SWIG_7(std::string const &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > const &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > const &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > const &,bool const,bool const,bool const)");; @@ -15543,7 +15599,7 @@ SWIGEXPORT SwigClassWrapper _wrap_TpetraReader_readSparseFile__SWIG_7(SwigArrayW SWIG_exception_impl("Tpetra::MatrixMarket::Reader< CMT >::Tpetra_MatrixMarket_Reader_Sl_CMT_Sg__readSparseFile__SWIG_7(std::string const &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > const &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > const &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > const &,bool const,bool const,bool const)", SWIG_UnknownError, "An unknown exception occurred", return SwigClassWrapper_uninitialized()); } } - fresult.ptr = (new Teuchos::RCP< Tpetra::CrsMatrix >(static_cast< const Teuchos::RCP< Tpetra::CrsMatrix >& >(result))); + fresult.cptr = (new Teuchos::RCP< Tpetra::CrsMatrix >(static_cast< const Teuchos::RCP< Tpetra::CrsMatrix >& >(result))); fresult.mem = SWIG_MOVE; return fresult; } @@ -15567,12 +15623,12 @@ SWIGEXPORT SwigClassWrapper _wrap_TpetraReader_readSparseFile__SWIG_8(SwigArrayW tempstr1 = std::string(static_cast(farg1->data), farg1->size); arg1 = &tempstr1; - arg2 = farg2->ptr ? static_cast< Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > * >(farg2->ptr) : &tempnull2; - arg3 = farg3->ptr ? static_cast< Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > * >(farg3->ptr) : &tempnull3; - arg4 = farg4->ptr ? static_cast< Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > * >(farg4->ptr) : &tempnull4; - arg5 = farg5->ptr ? static_cast< Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > * >(farg5->ptr) : &tempnull5; - arg6 = *farg6; - arg7 = *farg7; + arg2 = farg2->cptr ? static_cast< Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > * >(farg2->cptr) : &tempnull2; + arg3 = farg3->cptr ? static_cast< Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > * >(farg3->cptr) : &tempnull3; + arg4 = farg4->cptr ? static_cast< Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > * >(farg4->cptr) : &tempnull4; + arg5 = farg5->cptr ? static_cast< Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > * >(farg5->cptr) : &tempnull5; + arg6 = static_cast< bool >(*farg6); + arg7 = static_cast< bool >(*farg7); { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::MatrixMarket::Reader< CMT >::Tpetra_MatrixMarket_Reader_Sl_CMT_Sg__readSparseFile__SWIG_7(std::string const &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > const &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > const &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > const &,bool const,bool const)");; @@ -15596,7 +15652,7 @@ SWIGEXPORT SwigClassWrapper _wrap_TpetraReader_readSparseFile__SWIG_8(SwigArrayW SWIG_exception_impl("Tpetra::MatrixMarket::Reader< CMT >::Tpetra_MatrixMarket_Reader_Sl_CMT_Sg__readSparseFile__SWIG_7(std::string const &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > const &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > const &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > const &,bool const,bool const)", SWIG_UnknownError, "An unknown exception occurred", return SwigClassWrapper_uninitialized()); } } - fresult.ptr = (new Teuchos::RCP< Tpetra::CrsMatrix >(static_cast< const Teuchos::RCP< Tpetra::CrsMatrix >& >(result))); + fresult.cptr = (new Teuchos::RCP< Tpetra::CrsMatrix >(static_cast< const Teuchos::RCP< Tpetra::CrsMatrix >& >(result))); fresult.mem = SWIG_MOVE; return fresult; } @@ -15619,11 +15675,11 @@ SWIGEXPORT SwigClassWrapper _wrap_TpetraReader_readSparseFile__SWIG_9(SwigArrayW tempstr1 = std::string(static_cast(farg1->data), farg1->size); arg1 = &tempstr1; - arg2 = farg2->ptr ? static_cast< Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > * >(farg2->ptr) : &tempnull2; - arg3 = farg3->ptr ? static_cast< Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > * >(farg3->ptr) : &tempnull3; - arg4 = farg4->ptr ? static_cast< Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > * >(farg4->ptr) : &tempnull4; - arg5 = farg5->ptr ? static_cast< Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > * >(farg5->ptr) : &tempnull5; - arg6 = *farg6; + arg2 = farg2->cptr ? static_cast< Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > * >(farg2->cptr) : &tempnull2; + arg3 = farg3->cptr ? static_cast< Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > * >(farg3->cptr) : &tempnull3; + arg4 = farg4->cptr ? static_cast< Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > * >(farg4->cptr) : &tempnull4; + arg5 = farg5->cptr ? static_cast< Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > * >(farg5->cptr) : &tempnull5; + arg6 = static_cast< bool >(*farg6); { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::MatrixMarket::Reader< CMT >::Tpetra_MatrixMarket_Reader_Sl_CMT_Sg__readSparseFile__SWIG_7(std::string const &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > const &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > const &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > const &,bool const)");; @@ -15647,7 +15703,7 @@ SWIGEXPORT SwigClassWrapper _wrap_TpetraReader_readSparseFile__SWIG_9(SwigArrayW SWIG_exception_impl("Tpetra::MatrixMarket::Reader< CMT >::Tpetra_MatrixMarket_Reader_Sl_CMT_Sg__readSparseFile__SWIG_7(std::string const &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > const &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > const &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > const &,bool const)", SWIG_UnknownError, "An unknown exception occurred", return SwigClassWrapper_uninitialized()); } } - fresult.ptr = (new Teuchos::RCP< Tpetra::CrsMatrix >(static_cast< const Teuchos::RCP< Tpetra::CrsMatrix >& >(result))); + fresult.cptr = (new Teuchos::RCP< Tpetra::CrsMatrix >(static_cast< const Teuchos::RCP< Tpetra::CrsMatrix >& >(result))); fresult.mem = SWIG_MOVE; return fresult; } @@ -15669,10 +15725,10 @@ SWIGEXPORT SwigClassWrapper _wrap_TpetraReader_readSparseFile__SWIG_10(SwigArray tempstr1 = std::string(static_cast(farg1->data), farg1->size); arg1 = &tempstr1; - arg2 = farg2->ptr ? static_cast< Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > * >(farg2->ptr) : &tempnull2; - arg3 = farg3->ptr ? static_cast< Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > * >(farg3->ptr) : &tempnull3; - arg4 = farg4->ptr ? static_cast< Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > * >(farg4->ptr) : &tempnull4; - arg5 = farg5->ptr ? static_cast< Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > * >(farg5->ptr) : &tempnull5; + arg2 = farg2->cptr ? static_cast< Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > * >(farg2->cptr) : &tempnull2; + arg3 = farg3->cptr ? static_cast< Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > * >(farg3->cptr) : &tempnull3; + arg4 = farg4->cptr ? static_cast< Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > * >(farg4->cptr) : &tempnull4; + arg5 = farg5->cptr ? static_cast< Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > * >(farg5->cptr) : &tempnull5; { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::MatrixMarket::Reader< CMT >::Tpetra_MatrixMarket_Reader_Sl_CMT_Sg__readSparseFile__SWIG_7(std::string const &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > const &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > const &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > const &)");; @@ -15696,7 +15752,7 @@ SWIGEXPORT SwigClassWrapper _wrap_TpetraReader_readSparseFile__SWIG_10(SwigArray SWIG_exception_impl("Tpetra::MatrixMarket::Reader< CMT >::Tpetra_MatrixMarket_Reader_Sl_CMT_Sg__readSparseFile__SWIG_7(std::string const &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > const &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > const &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > const &)", SWIG_UnknownError, "An unknown exception occurred", return SwigClassWrapper_uninitialized()); } } - fresult.ptr = (new Teuchos::RCP< Tpetra::CrsMatrix >(static_cast< const Teuchos::RCP< Tpetra::CrsMatrix >& >(result))); + fresult.cptr = (new Teuchos::RCP< Tpetra::CrsMatrix >(static_cast< const Teuchos::RCP< Tpetra::CrsMatrix >& >(result))); fresult.mem = SWIG_MOVE; return fresult; } @@ -15716,10 +15772,10 @@ SWIGEXPORT SwigClassWrapper _wrap_TpetraReader_readDenseFile__SWIG_0(SwigArrayWr tempstr1 = std::string(static_cast(farg1->data), farg1->size); arg1 = &tempstr1; - arg2 = farg2->ptr ? static_cast< Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::comm_type const > * >(farg2->ptr) : &tempnull2; - arg3 = farg3->ptr ? static_cast< Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > * >(farg3->ptr) : &tempnull3; - arg4 = *farg4; - arg5 = *farg5; + arg2 = farg2->cptr ? static_cast< Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::comm_type const > * >(farg2->cptr) : &tempnull2; + arg3 = farg3->cptr ? static_cast< Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > * >(farg3->cptr) : &tempnull3; + arg4 = static_cast< bool >(*farg4); + arg5 = static_cast< bool >(*farg5); { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::MatrixMarket::Reader< CMT >::Tpetra_MatrixMarket_Reader_Sl_CMT_Sg__readDenseFile__SWIG_0(std::string const &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::comm_type const > const &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > &,bool const,bool const)");; @@ -15743,7 +15799,7 @@ SWIGEXPORT SwigClassWrapper _wrap_TpetraReader_readDenseFile__SWIG_0(SwigArrayWr SWIG_exception_impl("Tpetra::MatrixMarket::Reader< CMT >::Tpetra_MatrixMarket_Reader_Sl_CMT_Sg__readDenseFile__SWIG_0(std::string const &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::comm_type const > const &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > &,bool const,bool const)", SWIG_UnknownError, "An unknown exception occurred", return SwigClassWrapper_uninitialized()); } } - fresult.ptr = (new Teuchos::RCP< Tpetra::MultiVector >(static_cast< const Teuchos::RCP< Tpetra::MultiVector >& >(result))); + fresult.cptr = (new Teuchos::RCP< Tpetra::MultiVector >(static_cast< const Teuchos::RCP< Tpetra::MultiVector >& >(result))); fresult.mem = SWIG_MOVE; return fresult; } @@ -15762,9 +15818,9 @@ SWIGEXPORT SwigClassWrapper _wrap_TpetraReader_readDenseFile__SWIG_1(SwigArrayWr tempstr1 = std::string(static_cast(farg1->data), farg1->size); arg1 = &tempstr1; - arg2 = farg2->ptr ? static_cast< Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::comm_type const > * >(farg2->ptr) : &tempnull2; - arg3 = farg3->ptr ? static_cast< Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > * >(farg3->ptr) : &tempnull3; - arg4 = *farg4; + arg2 = farg2->cptr ? static_cast< Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::comm_type const > * >(farg2->cptr) : &tempnull2; + arg3 = farg3->cptr ? static_cast< Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > * >(farg3->cptr) : &tempnull3; + arg4 = static_cast< bool >(*farg4); { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::MatrixMarket::Reader< CMT >::Tpetra_MatrixMarket_Reader_Sl_CMT_Sg__readDenseFile__SWIG_0(std::string const &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::comm_type const > const &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > &,bool const)");; @@ -15788,7 +15844,7 @@ SWIGEXPORT SwigClassWrapper _wrap_TpetraReader_readDenseFile__SWIG_1(SwigArrayWr SWIG_exception_impl("Tpetra::MatrixMarket::Reader< CMT >::Tpetra_MatrixMarket_Reader_Sl_CMT_Sg__readDenseFile__SWIG_0(std::string const &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::comm_type const > const &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > &,bool const)", SWIG_UnknownError, "An unknown exception occurred", return SwigClassWrapper_uninitialized()); } } - fresult.ptr = (new Teuchos::RCP< Tpetra::MultiVector >(static_cast< const Teuchos::RCP< Tpetra::MultiVector >& >(result))); + fresult.cptr = (new Teuchos::RCP< Tpetra::MultiVector >(static_cast< const Teuchos::RCP< Tpetra::MultiVector >& >(result))); fresult.mem = SWIG_MOVE; return fresult; } @@ -15806,8 +15862,8 @@ SWIGEXPORT SwigClassWrapper _wrap_TpetraReader_readDenseFile__SWIG_2(SwigArrayWr tempstr1 = std::string(static_cast(farg1->data), farg1->size); arg1 = &tempstr1; - arg2 = farg2->ptr ? static_cast< Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::comm_type const > * >(farg2->ptr) : &tempnull2; - arg3 = farg3->ptr ? static_cast< Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > * >(farg3->ptr) : &tempnull3; + arg2 = farg2->cptr ? static_cast< Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::comm_type const > * >(farg2->cptr) : &tempnull2; + arg3 = farg3->cptr ? static_cast< Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > * >(farg3->cptr) : &tempnull3; { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::MatrixMarket::Reader< CMT >::Tpetra_MatrixMarket_Reader_Sl_CMT_Sg__readDenseFile__SWIG_0(std::string const &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::comm_type const > const &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > &)");; @@ -15831,7 +15887,7 @@ SWIGEXPORT SwigClassWrapper _wrap_TpetraReader_readDenseFile__SWIG_2(SwigArrayWr SWIG_exception_impl("Tpetra::MatrixMarket::Reader< CMT >::Tpetra_MatrixMarket_Reader_Sl_CMT_Sg__readDenseFile__SWIG_0(std::string const &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::comm_type const > const &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > &)", SWIG_UnknownError, "An unknown exception occurred", return SwigClassWrapper_uninitialized()); } } - fresult.ptr = (new Teuchos::RCP< Tpetra::MultiVector >(static_cast< const Teuchos::RCP< Tpetra::MultiVector >& >(result))); + fresult.cptr = (new Teuchos::RCP< Tpetra::MultiVector >(static_cast< const Teuchos::RCP< Tpetra::MultiVector >& >(result))); fresult.mem = SWIG_MOVE; return fresult; } @@ -15849,9 +15905,9 @@ SWIGEXPORT SwigClassWrapper _wrap_TpetraReader_readMapFile__SWIG_0(SwigArrayWrap tempstr1 = std::string(static_cast(farg1->data), farg1->size); arg1 = &tempstr1; - arg2 = farg2->ptr ? static_cast< Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::comm_type const > * >(farg2->ptr) : &tempnull2; - arg3 = *farg3; - arg4 = *farg4; + arg2 = farg2->cptr ? static_cast< Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::comm_type const > * >(farg2->cptr) : &tempnull2; + arg3 = static_cast< bool >(*farg3); + arg4 = static_cast< bool >(*farg4); { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::MatrixMarket::Reader< CMT >::Tpetra_MatrixMarket_Reader_Sl_CMT_Sg__readMapFile__SWIG_0(std::string const &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::comm_type const > const &,bool const,bool const)");; @@ -15875,7 +15931,7 @@ SWIGEXPORT SwigClassWrapper _wrap_TpetraReader_readMapFile__SWIG_0(SwigArrayWrap SWIG_exception_impl("Tpetra::MatrixMarket::Reader< CMT >::Tpetra_MatrixMarket_Reader_Sl_CMT_Sg__readMapFile__SWIG_0(std::string const &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::comm_type const > const &,bool const,bool const)", SWIG_UnknownError, "An unknown exception occurred", return SwigClassWrapper_uninitialized()); } } - fresult.ptr = (new Teuchos::RCP >(static_cast< const Teuchos::RCP >& >(result))); + fresult.cptr = (new Teuchos::RCP >(static_cast< const Teuchos::RCP >& >(result))); fresult.mem = SWIG_MOVE; return fresult; } @@ -15892,8 +15948,8 @@ SWIGEXPORT SwigClassWrapper _wrap_TpetraReader_readMapFile__SWIG_1(SwigArrayWrap tempstr1 = std::string(static_cast(farg1->data), farg1->size); arg1 = &tempstr1; - arg2 = farg2->ptr ? static_cast< Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::comm_type const > * >(farg2->ptr) : &tempnull2; - arg3 = *farg3; + arg2 = farg2->cptr ? static_cast< Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::comm_type const > * >(farg2->cptr) : &tempnull2; + arg3 = static_cast< bool >(*farg3); { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::MatrixMarket::Reader< CMT >::Tpetra_MatrixMarket_Reader_Sl_CMT_Sg__readMapFile__SWIG_0(std::string const &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::comm_type const > const &,bool const)");; @@ -15917,7 +15973,7 @@ SWIGEXPORT SwigClassWrapper _wrap_TpetraReader_readMapFile__SWIG_1(SwigArrayWrap SWIG_exception_impl("Tpetra::MatrixMarket::Reader< CMT >::Tpetra_MatrixMarket_Reader_Sl_CMT_Sg__readMapFile__SWIG_0(std::string const &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::comm_type const > const &,bool const)", SWIG_UnknownError, "An unknown exception occurred", return SwigClassWrapper_uninitialized()); } } - fresult.ptr = (new Teuchos::RCP >(static_cast< const Teuchos::RCP >& >(result))); + fresult.cptr = (new Teuchos::RCP >(static_cast< const Teuchos::RCP >& >(result))); fresult.mem = SWIG_MOVE; return fresult; } @@ -15933,7 +15989,7 @@ SWIGEXPORT SwigClassWrapper _wrap_TpetraReader_readMapFile__SWIG_2(SwigArrayWrap tempstr1 = std::string(static_cast(farg1->data), farg1->size); arg1 = &tempstr1; - arg2 = farg2->ptr ? static_cast< Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::comm_type const > * >(farg2->ptr) : &tempnull2; + arg2 = farg2->cptr ? static_cast< Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::comm_type const > * >(farg2->cptr) : &tempnull2; { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::MatrixMarket::Reader< CMT >::Tpetra_MatrixMarket_Reader_Sl_CMT_Sg__readMapFile__SWIG_0(std::string const &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::comm_type const > const &)");; @@ -15957,7 +16013,7 @@ SWIGEXPORT SwigClassWrapper _wrap_TpetraReader_readMapFile__SWIG_2(SwigArrayWrap SWIG_exception_impl("Tpetra::MatrixMarket::Reader< CMT >::Tpetra_MatrixMarket_Reader_Sl_CMT_Sg__readMapFile__SWIG_0(std::string const &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::comm_type const > const &)", SWIG_UnknownError, "An unknown exception occurred", return SwigClassWrapper_uninitialized()); } } - fresult.ptr = (new Teuchos::RCP >(static_cast< const Teuchos::RCP >& >(result))); + fresult.cptr = (new Teuchos::RCP >(static_cast< const Teuchos::RCP >& >(result))); fresult.mem = SWIG_MOVE; return fresult; } @@ -15990,7 +16046,7 @@ SWIGEXPORT SwigClassWrapper _wrap_new_TpetraReader() { SWIG_exception_impl("Tpetra::MatrixMarket::Reader< CMT >::Reader()", SWIG_UnknownError, "An unknown exception occurred", return SwigClassWrapper_uninitialized()); } } - fresult.ptr = result ? new Teuchos::RCP< Tpetra::MatrixMarket::Reader >(result SWIG_NO_NULL_DELETER_1) : NULL; + fresult.cptr = result ? new Teuchos::RCP< Tpetra::MatrixMarket::Reader >(result SWIG_NO_NULL_DELETER_1) : NULL; fresult.mem = SWIG_MOVE; return fresult; } @@ -16000,8 +16056,8 @@ SWIGEXPORT void _wrap_delete_TpetraReader(SwigClassWrapper const *farg1) { Tpetra::MatrixMarket::Reader< CMT > *arg1 = (Tpetra::MatrixMarket::Reader< CMT > *) 0 ; Teuchos::RCP< Tpetra::MatrixMarket::Reader< CMT > > *smartarg1 ; - smartarg1 = static_cast< Teuchos::RCP< Tpetra::MatrixMarket::Reader >* >(farg1->ptr); - arg1 = smartarg1 ? smartarg1->get() : NULL; + smartarg1 = static_cast< Teuchos::RCP< Tpetra::MatrixMarket::Reader >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::MatrixMarket::Reader* >(smartarg1->get()) : NULL; { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::MatrixMarket::Reader< CMT >::~Reader()");; @@ -16030,7 +16086,7 @@ SWIGEXPORT void _wrap_delete_TpetraReader(SwigClassWrapper const *farg1) { SWIGEXPORT void _wrap_assign_TpetraReader(SwigClassWrapper * self, SwigClassWrapper const * other) { - typedef ::Teuchos::RCP< Tpetra::MatrixMarket::Reader > swig_lhs_classtype; + typedef Teuchos::RCP< Tpetra::MatrixMarket::Reader > swig_lhs_classtype; SWIG_assign(swig_lhs_classtype, self, swig_lhs_classtype, const_cast(other), 0 | swig::IS_DESTR | swig::IS_COPY_CONSTR); @@ -16046,8 +16102,8 @@ SWIGEXPORT void _wrap_TpetraWriter_writeMapFile(SwigArrayWrapper *farg1, SwigCla tempstr1 = std::string(static_cast(farg1->data), farg1->size); arg1 = &tempstr1; SWIG_check_sp_nonnull(farg2, "Tpetra::MatrixMarket::Writer< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > >::map_type *", "TpetraMap", "Tpetra::MatrixMarket::Writer< CMT >::writeMapFile(std::string const &,Tpetra::MatrixMarket::Writer< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > >::map_type const &)", return ) - smartarg2 = static_cast< Teuchos::RCP >* >(farg2->ptr); - arg2 = const_cast*>(smartarg2->get()); + smartarg2 = static_cast< Teuchos::RCP >* >(farg2->cptr); + arg2 = const_cast< Tpetra::Map* >(smartarg2->get()); { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::MatrixMarket::Writer< CMT >::writeMapFile(std::string const &,Tpetra::MatrixMarket::Writer< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > >::map_type const &)");; @@ -16088,12 +16144,12 @@ SWIGEXPORT void _wrap_TpetraWriter_writeSparseFile__SWIG_0(SwigArrayWrapper *far tempstr1 = std::string(static_cast(farg1->data), farg1->size); arg1 = &tempstr1; - arg2 = farg2->ptr ? static_cast< Teuchos::RCP< Tpetra::MatrixMarket::Writer< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > >::sparse_matrix_type const > * >(farg2->ptr) : &tempnull2; + arg2 = farg2->cptr ? static_cast< Teuchos::RCP< Tpetra::MatrixMarket::Writer< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > >::sparse_matrix_type const > * >(farg2->cptr) : &tempnull2; tempstr3 = std::string(static_cast(farg3->data), farg3->size); arg3 = &tempstr3; tempstr4 = std::string(static_cast(farg4->data), farg4->size); arg4 = &tempstr4; - arg5 = *farg5; + arg5 = static_cast< bool >(*farg5); { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::MatrixMarket::Writer< CMT >::Tpetra_MatrixMarket_Writer_Sl_CMT_Sg__writeSparseFile__SWIG_0(std::string const &,Teuchos::RCP< Tpetra::MatrixMarket::Writer< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > >::sparse_matrix_type const > const &,std::string const &,std::string const &,bool const)");; @@ -16133,7 +16189,7 @@ SWIGEXPORT void _wrap_TpetraWriter_writeSparseFile__SWIG_1(SwigArrayWrapper *far tempstr1 = std::string(static_cast(farg1->data), farg1->size); arg1 = &tempstr1; - arg2 = farg2->ptr ? static_cast< Teuchos::RCP< Tpetra::MatrixMarket::Writer< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > >::sparse_matrix_type const > * >(farg2->ptr) : &tempnull2; + arg2 = farg2->cptr ? static_cast< Teuchos::RCP< Tpetra::MatrixMarket::Writer< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > >::sparse_matrix_type const > * >(farg2->cptr) : &tempnull2; tempstr3 = std::string(static_cast(farg3->data), farg3->size); arg3 = &tempstr3; tempstr4 = std::string(static_cast(farg4->data), farg4->size); @@ -16174,8 +16230,8 @@ SWIGEXPORT void _wrap_TpetraWriter_writeSparseFile__SWIG_2(SwigArrayWrapper *far tempstr1 = std::string(static_cast(farg1->data), farg1->size); arg1 = &tempstr1; - arg2 = farg2->ptr ? static_cast< Teuchos::RCP< Tpetra::MatrixMarket::Writer< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > >::sparse_matrix_type const > * >(farg2->ptr) : &tempnull2; - arg3 = *farg3; + arg2 = farg2->cptr ? static_cast< Teuchos::RCP< Tpetra::MatrixMarket::Writer< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > >::sparse_matrix_type const > * >(farg2->cptr) : &tempnull2; + arg3 = static_cast< bool >(*farg3); { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::MatrixMarket::Writer< CMT >::Tpetra_MatrixMarket_Writer_Sl_CMT_Sg__writeSparseFile__SWIG_2(std::string const &,Teuchos::RCP< Tpetra::MatrixMarket::Writer< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > >::sparse_matrix_type const > const &,bool const)");; @@ -16211,7 +16267,7 @@ SWIGEXPORT void _wrap_TpetraWriter_writeSparseFile__SWIG_3(SwigArrayWrapper *far tempstr1 = std::string(static_cast(farg1->data), farg1->size); arg1 = &tempstr1; - arg2 = farg2->ptr ? static_cast< Teuchos::RCP< Tpetra::MatrixMarket::Writer< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > >::sparse_matrix_type const > * >(farg2->ptr) : &tempnull2; + arg2 = farg2->cptr ? static_cast< Teuchos::RCP< Tpetra::MatrixMarket::Writer< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > >::sparse_matrix_type const > * >(farg2->cptr) : &tempnull2; { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::MatrixMarket::Writer< CMT >::Tpetra_MatrixMarket_Writer_Sl_CMT_Sg__writeSparseFile__SWIG_2(std::string const &,Teuchos::RCP< Tpetra::MatrixMarket::Writer< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > >::sparse_matrix_type const > const &)");; @@ -16252,12 +16308,12 @@ SWIGEXPORT void _wrap_TpetraWriter_writeSparseGraphFile__SWIG_0(SwigArrayWrapper tempstr1 = std::string(static_cast(farg1->data), farg1->size); arg1 = &tempstr1; - arg2 = farg2->ptr ? static_cast< Teuchos::RCP< Tpetra::MatrixMarket::Writer< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > >::crs_graph_type const > * >(farg2->ptr) : &tempnull2; + arg2 = farg2->cptr ? static_cast< Teuchos::RCP< Tpetra::MatrixMarket::Writer< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > >::crs_graph_type const > * >(farg2->cptr) : &tempnull2; tempstr3 = std::string(static_cast(farg3->data), farg3->size); arg3 = &tempstr3; tempstr4 = std::string(static_cast(farg4->data), farg4->size); arg4 = &tempstr4; - arg5 = *farg5; + arg5 = static_cast< bool >(*farg5); { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::MatrixMarket::Writer< CMT >::Tpetra_MatrixMarket_Writer_Sl_CMT_Sg__writeSparseGraphFile__SWIG_0(std::string const &,Teuchos::RCP< Tpetra::MatrixMarket::Writer< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > >::crs_graph_type const > const &,std::string const &,std::string const &,bool const)");; @@ -16297,7 +16353,7 @@ SWIGEXPORT void _wrap_TpetraWriter_writeSparseGraphFile__SWIG_1(SwigArrayWrapper tempstr1 = std::string(static_cast(farg1->data), farg1->size); arg1 = &tempstr1; - arg2 = farg2->ptr ? static_cast< Teuchos::RCP< Tpetra::MatrixMarket::Writer< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > >::crs_graph_type const > * >(farg2->ptr) : &tempnull2; + arg2 = farg2->cptr ? static_cast< Teuchos::RCP< Tpetra::MatrixMarket::Writer< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > >::crs_graph_type const > * >(farg2->cptr) : &tempnull2; tempstr3 = std::string(static_cast(farg3->data), farg3->size); arg3 = &tempstr3; tempstr4 = std::string(static_cast(farg4->data), farg4->size); @@ -16338,8 +16394,8 @@ SWIGEXPORT void _wrap_TpetraWriter_writeSparseGraphFile__SWIG_2(SwigArrayWrapper tempstr1 = std::string(static_cast(farg1->data), farg1->size); arg1 = &tempstr1; - arg2 = farg2->ptr ? static_cast< Teuchos::RCP< Tpetra::MatrixMarket::Writer< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > >::crs_graph_type const > * >(farg2->ptr) : &tempnull2; - arg3 = *farg3; + arg2 = farg2->cptr ? static_cast< Teuchos::RCP< Tpetra::MatrixMarket::Writer< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > >::crs_graph_type const > * >(farg2->cptr) : &tempnull2; + arg3 = static_cast< bool >(*farg3); { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::MatrixMarket::Writer< CMT >::Tpetra_MatrixMarket_Writer_Sl_CMT_Sg__writeSparseGraphFile__SWIG_2(std::string const &,Teuchos::RCP< Tpetra::MatrixMarket::Writer< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > >::crs_graph_type const > const &,bool const)");; @@ -16375,7 +16431,7 @@ SWIGEXPORT void _wrap_TpetraWriter_writeSparseGraphFile__SWIG_3(SwigArrayWrapper tempstr1 = std::string(static_cast(farg1->data), farg1->size); arg1 = &tempstr1; - arg2 = farg2->ptr ? static_cast< Teuchos::RCP< Tpetra::MatrixMarket::Writer< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > >::crs_graph_type const > * >(farg2->ptr) : &tempnull2; + arg2 = farg2->cptr ? static_cast< Teuchos::RCP< Tpetra::MatrixMarket::Writer< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > >::crs_graph_type const > * >(farg2->cptr) : &tempnull2; { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::MatrixMarket::Writer< CMT >::Tpetra_MatrixMarket_Writer_Sl_CMT_Sg__writeSparseGraphFile__SWIG_2(std::string const &,Teuchos::RCP< Tpetra::MatrixMarket::Writer< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > >::crs_graph_type const > const &)");; @@ -16415,7 +16471,7 @@ SWIGEXPORT void _wrap_TpetraWriter_writeDenseFile__SWIG_0(SwigArrayWrapper *farg tempstr1 = std::string(static_cast(farg1->data), farg1->size); arg1 = &tempstr1; - arg2 = farg2->ptr ? static_cast< Teuchos::RCP< Tpetra::MatrixMarket::Writer< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > >::multivector_type const > * >(farg2->ptr) : &tempnull2; + arg2 = farg2->cptr ? static_cast< Teuchos::RCP< Tpetra::MatrixMarket::Writer< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > >::multivector_type const > * >(farg2->cptr) : &tempnull2; tempstr3 = std::string(static_cast(farg3->data), farg3->size); arg3 = &tempstr3; tempstr4 = std::string(static_cast(farg4->data), farg4->size); @@ -16455,7 +16511,7 @@ SWIGEXPORT void _wrap_TpetraWriter_writeDenseFile__SWIG_1(SwigArrayWrapper *farg tempstr1 = std::string(static_cast(farg1->data), farg1->size); arg1 = &tempstr1; - arg2 = farg2->ptr ? static_cast< Teuchos::RCP< Tpetra::MatrixMarket::Writer< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > >::multivector_type const > * >(farg2->ptr) : &tempnull2; + arg2 = farg2->cptr ? static_cast< Teuchos::RCP< Tpetra::MatrixMarket::Writer< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > >::multivector_type const > * >(farg2->cptr) : &tempnull2; { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::MatrixMarket::Writer< CMT >::Tpetra_MatrixMarket_Writer_Sl_CMT_Sg__writeDenseFile__SWIG_1(std::string const &,Teuchos::RCP< Tpetra::MatrixMarket::Writer< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > >::multivector_type const > const &)");; @@ -16510,7 +16566,7 @@ SWIGEXPORT SwigClassWrapper _wrap_new_TpetraWriter() { SWIG_exception_impl("Tpetra::MatrixMarket::Writer< CMT >::Writer()", SWIG_UnknownError, "An unknown exception occurred", return SwigClassWrapper_uninitialized()); } } - fresult.ptr = result ? new Teuchos::RCP< Tpetra::MatrixMarket::Writer >(result SWIG_NO_NULL_DELETER_1) : NULL; + fresult.cptr = result ? new Teuchos::RCP< Tpetra::MatrixMarket::Writer >(result SWIG_NO_NULL_DELETER_1) : NULL; fresult.mem = SWIG_MOVE; return fresult; } @@ -16520,8 +16576,8 @@ SWIGEXPORT void _wrap_delete_TpetraWriter(SwigClassWrapper const *farg1) { Tpetra::MatrixMarket::Writer< CMT > *arg1 = (Tpetra::MatrixMarket::Writer< CMT > *) 0 ; Teuchos::RCP< Tpetra::MatrixMarket::Writer< CMT > > *smartarg1 ; - smartarg1 = static_cast< Teuchos::RCP< Tpetra::MatrixMarket::Writer >* >(farg1->ptr); - arg1 = smartarg1 ? smartarg1->get() : NULL; + smartarg1 = static_cast< Teuchos::RCP< Tpetra::MatrixMarket::Writer >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::MatrixMarket::Writer* >(smartarg1->get()) : NULL; { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::MatrixMarket::Writer< CMT >::~Writer()");; @@ -16550,7 +16606,7 @@ SWIGEXPORT void _wrap_delete_TpetraWriter(SwigClassWrapper const *farg1) { SWIGEXPORT void _wrap_assign_TpetraWriter(SwigClassWrapper * self, SwigClassWrapper const * other) { - typedef ::Teuchos::RCP< Tpetra::MatrixMarket::Writer > swig_lhs_classtype; + typedef Teuchos::RCP< Tpetra::MatrixMarket::Writer > swig_lhs_classtype; SWIG_assign(swig_lhs_classtype, self, swig_lhs_classtype, const_cast(other), 0 | swig::IS_DESTR | swig::IS_COPY_CONSTR); @@ -16573,20 +16629,20 @@ SWIGEXPORT void _wrap_TpetraMatrixMatrixMultiply__SWIG_0(SwigClassWrapper const Teuchos::RCP< Teuchos::ParameterList > tempnull8 ; SWIG_check_sp_nonnull(farg1, "Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > *", "TpetraCrsMatrix", "Tpetra::MatrixMatrix::Multiply< SC,LO,GO,NO >(Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &,bool,Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &,bool,Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > &,bool,std::string const &,Teuchos::RCP< Teuchos::ParameterList > const &)", return ) - smartarg1 = static_cast< Teuchos::RCP >* >(farg1->ptr); - arg1 = const_cast*>(smartarg1->get()); - arg2 = *farg2; + smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); + arg1 = const_cast< Tpetra::CrsMatrix* >(smartarg1->get()); + arg2 = static_cast< bool >(*farg2); SWIG_check_sp_nonnull(farg3, "Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > *", "TpetraCrsMatrix", "Tpetra::MatrixMatrix::Multiply< SC,LO,GO,NO >(Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &,bool,Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &,bool,Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > &,bool,std::string const &,Teuchos::RCP< Teuchos::ParameterList > const &)", return ) - smartarg3 = static_cast< Teuchos::RCP >* >(farg3->ptr); - arg3 = const_cast*>(smartarg3->get()); - arg4 = *farg4; + smartarg3 = static_cast< Teuchos::RCP >* >(farg3->cptr); + arg3 = const_cast< Tpetra::CrsMatrix* >(smartarg3->get()); + arg4 = static_cast< bool >(*farg4); SWIG_check_sp_nonnull(farg5, "Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > *", "TpetraCrsMatrix", "Tpetra::MatrixMatrix::Multiply< SC,LO,GO,NO >(Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &,bool,Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &,bool,Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > &,bool,std::string const &,Teuchos::RCP< Teuchos::ParameterList > const &)", return ) - smartarg5 = static_cast< Teuchos::RCP< Tpetra::CrsMatrix >* >(farg5->ptr); - arg5 = smartarg5->get(); - arg6 = *farg6; + smartarg5 = static_cast< Teuchos::RCP< Tpetra::CrsMatrix >* >(farg5->cptr); + arg5 = const_cast< Tpetra::CrsMatrix* >(smartarg5->get()); + arg6 = static_cast< bool >(*farg6); tempstr7 = std::string(static_cast(farg7->data), farg7->size); arg7 = &tempstr7; - arg8 = farg8->ptr ? static_cast< Teuchos::RCP< Teuchos::ParameterList > * >(farg8->ptr) : &tempnull8; + arg8 = farg8->cptr ? static_cast< Teuchos::RCP< Teuchos::ParameterList > * >(farg8->cptr) : &tempnull8; { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::MatrixMatrix::Multiply< SC,LO,GO,NO >(Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &,bool,Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &,bool,Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > &,bool,std::string const &,Teuchos::RCP< Teuchos::ParameterList > const &)");; @@ -16628,17 +16684,17 @@ SWIGEXPORT void _wrap_TpetraMatrixMatrixMultiply__SWIG_1(SwigClassWrapper const std::string tempstr7 ; SWIG_check_sp_nonnull(farg1, "Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > *", "TpetraCrsMatrix", "Tpetra::MatrixMatrix::Multiply< SC,LO,GO,NO >(Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &,bool,Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &,bool,Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > &,bool,std::string const &)", return ) - smartarg1 = static_cast< Teuchos::RCP >* >(farg1->ptr); - arg1 = const_cast*>(smartarg1->get()); - arg2 = *farg2; + smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); + arg1 = const_cast< Tpetra::CrsMatrix* >(smartarg1->get()); + arg2 = static_cast< bool >(*farg2); SWIG_check_sp_nonnull(farg3, "Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > *", "TpetraCrsMatrix", "Tpetra::MatrixMatrix::Multiply< SC,LO,GO,NO >(Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &,bool,Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &,bool,Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > &,bool,std::string const &)", return ) - smartarg3 = static_cast< Teuchos::RCP >* >(farg3->ptr); - arg3 = const_cast*>(smartarg3->get()); - arg4 = *farg4; + smartarg3 = static_cast< Teuchos::RCP >* >(farg3->cptr); + arg3 = const_cast< Tpetra::CrsMatrix* >(smartarg3->get()); + arg4 = static_cast< bool >(*farg4); SWIG_check_sp_nonnull(farg5, "Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > *", "TpetraCrsMatrix", "Tpetra::MatrixMatrix::Multiply< SC,LO,GO,NO >(Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &,bool,Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &,bool,Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > &,bool,std::string const &)", return ) - smartarg5 = static_cast< Teuchos::RCP< Tpetra::CrsMatrix >* >(farg5->ptr); - arg5 = smartarg5->get(); - arg6 = *farg6; + smartarg5 = static_cast< Teuchos::RCP< Tpetra::CrsMatrix >* >(farg5->cptr); + arg5 = const_cast< Tpetra::CrsMatrix* >(smartarg5->get()); + arg6 = static_cast< bool >(*farg6); tempstr7 = std::string(static_cast(farg7->data), farg7->size); arg7 = &tempstr7; { @@ -16680,17 +16736,17 @@ SWIGEXPORT void _wrap_TpetraMatrixMatrixMultiply__SWIG_2(SwigClassWrapper const Teuchos::RCP< Tpetra::CrsMatrix< SC,LO,GO,NO > > *smartarg5 ; SWIG_check_sp_nonnull(farg1, "Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > *", "TpetraCrsMatrix", "Tpetra::MatrixMatrix::Multiply< SC,LO,GO,NO >(Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &,bool,Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &,bool,Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > &,bool)", return ) - smartarg1 = static_cast< Teuchos::RCP >* >(farg1->ptr); - arg1 = const_cast*>(smartarg1->get()); - arg2 = *farg2; + smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); + arg1 = const_cast< Tpetra::CrsMatrix* >(smartarg1->get()); + arg2 = static_cast< bool >(*farg2); SWIG_check_sp_nonnull(farg3, "Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > *", "TpetraCrsMatrix", "Tpetra::MatrixMatrix::Multiply< SC,LO,GO,NO >(Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &,bool,Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &,bool,Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > &,bool)", return ) - smartarg3 = static_cast< Teuchos::RCP >* >(farg3->ptr); - arg3 = const_cast*>(smartarg3->get()); - arg4 = *farg4; + smartarg3 = static_cast< Teuchos::RCP >* >(farg3->cptr); + arg3 = const_cast< Tpetra::CrsMatrix* >(smartarg3->get()); + arg4 = static_cast< bool >(*farg4); SWIG_check_sp_nonnull(farg5, "Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > *", "TpetraCrsMatrix", "Tpetra::MatrixMatrix::Multiply< SC,LO,GO,NO >(Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &,bool,Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &,bool,Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > &,bool)", return ) - smartarg5 = static_cast< Teuchos::RCP< Tpetra::CrsMatrix >* >(farg5->ptr); - arg5 = smartarg5->get(); - arg6 = *farg6; + smartarg5 = static_cast< Teuchos::RCP< Tpetra::CrsMatrix >* >(farg5->cptr); + arg5 = const_cast< Tpetra::CrsMatrix* >(smartarg5->get()); + arg6 = static_cast< bool >(*farg6); { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::MatrixMatrix::Multiply< SC,LO,GO,NO >(Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &,bool,Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &,bool,Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > &,bool)");; @@ -16729,16 +16785,16 @@ SWIGEXPORT void _wrap_TpetraMatrixMatrixMultiply__SWIG_3(SwigClassWrapper const Teuchos::RCP< Tpetra::CrsMatrix< SC,LO,GO,NO > > *smartarg5 ; SWIG_check_sp_nonnull(farg1, "Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > *", "TpetraCrsMatrix", "Tpetra::MatrixMatrix::Multiply< SC,LO,GO,NO >(Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &,bool,Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &,bool,Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > &)", return ) - smartarg1 = static_cast< Teuchos::RCP >* >(farg1->ptr); - arg1 = const_cast*>(smartarg1->get()); - arg2 = *farg2; + smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); + arg1 = const_cast< Tpetra::CrsMatrix* >(smartarg1->get()); + arg2 = static_cast< bool >(*farg2); SWIG_check_sp_nonnull(farg3, "Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > *", "TpetraCrsMatrix", "Tpetra::MatrixMatrix::Multiply< SC,LO,GO,NO >(Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &,bool,Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &,bool,Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > &)", return ) - smartarg3 = static_cast< Teuchos::RCP >* >(farg3->ptr); - arg3 = const_cast*>(smartarg3->get()); - arg4 = *farg4; + smartarg3 = static_cast< Teuchos::RCP >* >(farg3->cptr); + arg3 = const_cast< Tpetra::CrsMatrix* >(smartarg3->get()); + arg4 = static_cast< bool >(*farg4); SWIG_check_sp_nonnull(farg5, "Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > *", "TpetraCrsMatrix", "Tpetra::MatrixMatrix::Multiply< SC,LO,GO,NO >(Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &,bool,Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &,bool,Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > &)", return ) - smartarg5 = static_cast< Teuchos::RCP< Tpetra::CrsMatrix >* >(farg5->ptr); - arg5 = smartarg5->get(); + smartarg5 = static_cast< Teuchos::RCP< Tpetra::CrsMatrix >* >(farg5->cptr); + arg5 = const_cast< Tpetra::CrsMatrix* >(smartarg5->get()); { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::MatrixMatrix::Multiply< SC,LO,GO,NO >(Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &,bool,Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &,bool,Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > &)");; @@ -16776,14 +16832,14 @@ SWIGEXPORT void _wrap_TpetraMatrixMatrixAdd__SWIG_0(SwigClassWrapper const *farg Teuchos::RCP< Tpetra::CrsMatrix< SC,LO,GO,NO > > *smartarg4 ; SWIG_check_sp_nonnull(farg1, "Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > *", "TpetraCrsMatrix", "Tpetra::MatrixMatrix::Add< SC,LO,GO,NO >(Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &,bool,double,Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > &,double)", return ) - smartarg1 = static_cast< Teuchos::RCP >* >(farg1->ptr); - arg1 = const_cast*>(smartarg1->get()); - arg2 = *farg2; - arg3 = *farg3; + smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); + arg1 = const_cast< Tpetra::CrsMatrix* >(smartarg1->get()); + arg2 = static_cast< bool >(*farg2); + arg3 = static_cast< double >(*farg3); SWIG_check_sp_nonnull(farg4, "Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > *", "TpetraCrsMatrix", "Tpetra::MatrixMatrix::Add< SC,LO,GO,NO >(Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &,bool,double,Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > &,double)", return ) - smartarg4 = static_cast< Teuchos::RCP< Tpetra::CrsMatrix >* >(farg4->ptr); - arg4 = smartarg4->get(); - arg5 = *farg5; + smartarg4 = static_cast< Teuchos::RCP< Tpetra::CrsMatrix >* >(farg4->cptr); + arg4 = const_cast< Tpetra::CrsMatrix* >(smartarg4->get()); + arg5 = static_cast< double >(*farg5); { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::MatrixMatrix::Add< SC,LO,GO,NO >(Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &,bool,double,Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > &,double)");; @@ -16823,16 +16879,16 @@ SWIGEXPORT void _wrap_TpetraMatrixMatrixAdd__SWIG_1(SwigClassWrapper const *farg Teuchos::RCP< Tpetra::CrsMatrix< SC,LO,GO,NO > const > *smartarg4 ; SWIG_check_sp_nonnull(farg1, "Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > *", "TpetraCrsMatrix", "Tpetra::MatrixMatrix::Add< SC,LO,GO,NO >(Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &,bool,double,Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &,bool,double,Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > >)", return ) - smartarg1 = static_cast< Teuchos::RCP >* >(farg1->ptr); - arg1 = const_cast*>(smartarg1->get()); - arg2 = *farg2; - arg3 = *farg3; + smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); + arg1 = const_cast< Tpetra::CrsMatrix* >(smartarg1->get()); + arg2 = static_cast< bool >(*farg2); + arg3 = static_cast< double >(*farg3); SWIG_check_sp_nonnull(farg4, "Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > *", "TpetraCrsMatrix", "Tpetra::MatrixMatrix::Add< SC,LO,GO,NO >(Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &,bool,double,Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &,bool,double,Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > >)", return ) - smartarg4 = static_cast< Teuchos::RCP >* >(farg4->ptr); - arg4 = const_cast*>(smartarg4->get()); - arg5 = *farg5; - arg6 = *farg6; - if (farg7->ptr) arg7 = *static_cast< Teuchos::RCP< Tpetra::CrsMatrix >* >(farg7->ptr); + smartarg4 = static_cast< Teuchos::RCP >* >(farg4->cptr); + arg4 = const_cast< Tpetra::CrsMatrix* >(smartarg4->get()); + arg5 = static_cast< bool >(*farg5); + arg6 = static_cast< double >(*farg6); + if (farg7->cptr) arg7 = *static_cast< Teuchos::RCP< Tpetra::CrsMatrix >* >(farg7->cptr); { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::MatrixMatrix::Add< SC,LO,GO,NO >(Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &,bool,double,Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &,bool,double,Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > >)");; diff --git a/src/utils/src/forerror.f90 b/src/utils/src/forerror.f90 index d462a027..f29db969 100644 --- a/src/utils/src/forerror.f90 +++ b/src/utils/src/forerror.f90 @@ -14,35 +14,36 @@ module forerror implicit none private - ! PUBLIC METHODS AND TYPES + ! DECLARATION CONSTRUCTS -type, bind(C) :: SwigArrayWrapper + integer(C_INT), bind(C), public :: fortrilinos_ierr + + type, bind(C) :: SwigArrayWrapper type(C_PTR), public :: data = C_NULL_PTR integer(C_SIZE_T), public :: size = 0 -end type - + end type public :: fortrilinos_get_serr - ! PARAMETERS - - integer(C_INT), bind(C), public :: fortrilinos_ierr - - - ! WRAPPER DECLARATIONS - interface +! WRAPPER DECLARATIONS +interface function swigc_fortrilinos_get_serr() & bind(C, name="_wrap_fortrilinos_get_serr") & result(fresult) use, intrinsic :: ISO_C_BINDING -import :: SwigArrayWrapper +import :: swigarraywrapper type(SwigArrayWrapper) :: fresult end function - end interface + subroutine SWIG_free(cptr) & + bind(C, name="free") + use, intrinsic :: ISO_C_BINDING + type(C_PTR), value :: cptr +end subroutine +end interface contains - ! FORTRAN PROXY CODE + ! MODULE SUBPROGRAMS subroutine SWIG_chararray_to_string(wrap, string) use, intrinsic :: ISO_C_BINDING @@ -61,10 +62,12 @@ function fortrilinos_get_serr() & result(swig_result) use, intrinsic :: ISO_C_BINDING character(kind=C_CHAR, len=:), allocatable :: swig_result + type(SwigArrayWrapper) :: fresult fresult = swigc_fortrilinos_get_serr() call SWIG_chararray_to_string(fresult, swig_result) +if (.false.) call SWIG_free(fresult%data) end function diff --git a/src/utils/src/forerrorFORTRAN_wrap.cxx b/src/utils/src/forerrorFORTRAN_wrap.cxx index 7ad0c968..45670c3e 100644 --- a/src/utils/src/forerrorFORTRAN_wrap.cxx +++ b/src/utils/src/forerrorFORTRAN_wrap.cxx @@ -191,7 +191,7 @@ template T SwigValueInit() { #define SWIG_exception_impl(DECL, CODE, MSG, RETURNNULL) \ - { throw std::logic_error("In " DECL ": " MSG); RETURNNULL; } + { throw std::logic_error("In " DECL ": " MSG); } extern "C" { @@ -250,6 +250,9 @@ SWIGINTERN SwigArrayWrapper SwigArrayWrapper_uninitialized() { } +#include + + #include @@ -259,14 +262,14 @@ SWIGINTERN SwigArrayWrapper SwigArrayWrapper_uninitialized() { // Stored exception message SWIGINTERN std::string* swig_last_exception_msg = NULL; // Inlined error retrieval function -SWIGINTERN const std::string& fortrilinos_get_serr() +SWIGINTERN const char* fortrilinos_get_serr() { if (!swig_last_exception_msg || swig_last_exception_msg->empty()) { SWIG_store_exception("UNKNOWN", SWIG_RuntimeError, "no error string was present"); } - return *swig_last_exception_msg; + return swig_last_exception_msg->c_str(); } extern "C" { @@ -313,11 +316,11 @@ extern "C" { #endif SWIGEXPORT SwigArrayWrapper _wrap_fortrilinos_get_serr() { SwigArrayWrapper fresult ; - std::string *result = 0 ; + char *result = 0 ; - result = (std::string *) &fortrilinos_get_serr(); - fresult.data = (result->empty() ? NULL : &(*result->begin())); - fresult.size = result->size(); + result = (char *)fortrilinos_get_serr(); + fresult.size = strlen(reinterpret_cast< const char* >(result)); + fresult.data = const_cast< char * >(result); return fresult; } diff --git a/swig_hash b/swig_hash new file mode 100644 index 00000000..39cba436 --- /dev/null +++ b/swig_hash @@ -0,0 +1 @@ +01c436496 From 912109608accd1bd0613ceaca779543296a612cb Mon Sep 17 00:00:00 2001 From: Seth R Johnson Date: Fri, 1 Feb 2019 10:20:37 -0500 Subject: [PATCH 02/40] Move generated files into "swig" subdirectory --- src/belos/src/CMakeLists.txt | 8 ++++---- src/belos/src/{ => swig}/forbelos.f90 | 0 src/belos/src/{ => swig}/forbelosFORTRAN_wrap.cxx | 0 src/interface/src/CMakeLists.txt | 8 ++++---- src/interface/src/{ => swig}/fortrilinos.f90 | 0 src/interface/src/{ => swig}/fortrilinosFORTRAN_wrap.cxx | 0 src/teuchos/src/CMakeLists.txt | 8 ++++---- src/teuchos/src/{ => swig}/forteuchos.f90 | 0 src/teuchos/src/{ => swig}/forteuchosFORTRAN_wrap.cxx | 0 src/tpetra/src/CMakeLists.txt | 8 ++++---- src/tpetra/src/{ => swig}/fortpetra.f90 | 0 src/tpetra/src/{ => swig}/fortpetraFORTRAN_wrap.cxx | 0 src/utils/src/CMakeLists.txt | 9 ++++----- src/utils/src/{ => swig}/forerror.f90 | 0 src/utils/src/{ => swig}/forerrorFORTRAN_wrap.cxx | 0 15 files changed, 20 insertions(+), 21 deletions(-) rename src/belos/src/{ => swig}/forbelos.f90 (100%) rename src/belos/src/{ => swig}/forbelosFORTRAN_wrap.cxx (100%) rename src/interface/src/{ => swig}/fortrilinos.f90 (100%) rename src/interface/src/{ => swig}/fortrilinosFORTRAN_wrap.cxx (100%) rename src/teuchos/src/{ => swig}/forteuchos.f90 (100%) rename src/teuchos/src/{ => swig}/forteuchosFORTRAN_wrap.cxx (100%) rename src/tpetra/src/{ => swig}/fortpetra.f90 (100%) rename src/tpetra/src/{ => swig}/fortpetraFORTRAN_wrap.cxx (100%) rename src/utils/src/{ => swig}/forerror.f90 (100%) rename src/utils/src/{ => swig}/forerrorFORTRAN_wrap.cxx (100%) diff --git a/src/belos/src/CMakeLists.txt b/src/belos/src/CMakeLists.txt index 046e3c92..7e239779 100644 --- a/src/belos/src/CMakeLists.txt +++ b/src/belos/src/CMakeLists.txt @@ -8,11 +8,11 @@ INCLUDE_DIRECTORIES(${CMAKE_CURRENT_BINARY_DIR}) IF (ForTrilinos_ENABLE_DeveloperMode) IF (ForTrilinos_EXPORT_SWIG) # Generate wrapper and proxy files since MPI is enabled - SET(CMAKE_SWIG_OUTDIR "${CMAKE_CURRENT_SOURCE_DIR}") + SET(CMAKE_SWIG_OUTDIR "${CMAKE_CURRENT_SOURCE_DIR}/swig") ENDIF() LIST(APPEND CMAKE_SWIG_FLAGS -I${CMAKE_CURRENT_SOURCE_DIR}/../../utils/src/) - MAKE_SWIG(MODULE forbelos + MAKE_SWIG_FORTRAN(MODULE forbelos SOURCE forbelos.i EXTRASRC ${EXTRA_SOURCE} ) @@ -20,8 +20,8 @@ IF (ForTrilinos_ENABLE_DeveloperMode) ELSE() # Use pre-generated files SET(GEN_SOURCE - forbelos.f90 - forbelosFORTRAN_wrap.cxx) + swig/forbelos.f90 + swig/forbelosFORTRAN_wrap.cxx) TRIBITS_ADD_LIBRARY( forbelos diff --git a/src/belos/src/forbelos.f90 b/src/belos/src/swig/forbelos.f90 similarity index 100% rename from src/belos/src/forbelos.f90 rename to src/belos/src/swig/forbelos.f90 diff --git a/src/belos/src/forbelosFORTRAN_wrap.cxx b/src/belos/src/swig/forbelosFORTRAN_wrap.cxx similarity index 100% rename from src/belos/src/forbelosFORTRAN_wrap.cxx rename to src/belos/src/swig/forbelosFORTRAN_wrap.cxx diff --git a/src/interface/src/CMakeLists.txt b/src/interface/src/CMakeLists.txt index 8c25313d..6c8528ff 100644 --- a/src/interface/src/CMakeLists.txt +++ b/src/interface/src/CMakeLists.txt @@ -17,11 +17,11 @@ ENDIF() IF (ForTrilinos_ENABLE_DeveloperMode) IF (ForTrilinos_EXPORT_SWIG) # Generate wrapper and proxy files since MPI is enabled - SET(CMAKE_SWIG_OUTDIR "${CMAKE_CURRENT_SOURCE_DIR}") + SET(CMAKE_SWIG_OUTDIR "${CMAKE_CURRENT_SOURCE_DIR}/swig") ENDIF() LIST(APPEND CMAKE_SWIG_FLAGS -I${CMAKE_CURRENT_SOURCE_DIR}/../../utils/src/) - MAKE_SWIG(MODULE fortrilinos + MAKE_SWIG_FORTRAN(MODULE fortrilinos SOURCE fortrilinos.i DEPLIBS ${Trilinos_LIBRARIES} EXTRASRC ${EXTRA_SOURCE} @@ -30,8 +30,8 @@ IF (ForTrilinos_ENABLE_DeveloperMode) ELSE() # Use pre-generated files SET(GEN_SOURCE - fortrilinos.f90 - fortrilinosFORTRAN_wrap.cxx) + swig/fortrilinos.f90 + swig/fortrilinosFORTRAN_wrap.cxx) TRIBITS_ADD_LIBRARY( fortrilinos diff --git a/src/interface/src/fortrilinos.f90 b/src/interface/src/swig/fortrilinos.f90 similarity index 100% rename from src/interface/src/fortrilinos.f90 rename to src/interface/src/swig/fortrilinos.f90 diff --git a/src/interface/src/fortrilinosFORTRAN_wrap.cxx b/src/interface/src/swig/fortrilinosFORTRAN_wrap.cxx similarity index 100% rename from src/interface/src/fortrilinosFORTRAN_wrap.cxx rename to src/interface/src/swig/fortrilinosFORTRAN_wrap.cxx diff --git a/src/teuchos/src/CMakeLists.txt b/src/teuchos/src/CMakeLists.txt index 21ab1f97..4b7e77f4 100644 --- a/src/teuchos/src/CMakeLists.txt +++ b/src/teuchos/src/CMakeLists.txt @@ -8,11 +8,11 @@ INCLUDE_DIRECTORIES(${CMAKE_CURRENT_BINARY_DIR}) IF (ForTrilinos_ENABLE_DeveloperMode) IF (ForTrilinos_EXPORT_SWIG) # Generate wrapper and proxy files since MPI is enabled - SET(CMAKE_SWIG_OUTDIR "${CMAKE_CURRENT_SOURCE_DIR}") + SET(CMAKE_SWIG_OUTDIR "${CMAKE_CURRENT_SOURCE_DIR}/swig") ENDIF() LIST(APPEND CMAKE_SWIG_FLAGS -I${CMAKE_CURRENT_SOURCE_DIR}/../../utils/src/) - MAKE_SWIG(MODULE forteuchos + MAKE_SWIG_FORTRAN(MODULE forteuchos SOURCE forteuchos.i DEPLIBS ${Trilinos_LIBRARIES} EXTRASRC ${EXTRA_SOURCE} @@ -21,8 +21,8 @@ IF (ForTrilinos_ENABLE_DeveloperMode) ELSE() # Use pre-generated files SET(GEN_SOURCE - forteuchos.f90 - forteuchosFORTRAN_wrap.cxx) + swig/forteuchos.f90 + swig/forteuchosFORTRAN_wrap.cxx) TRIBITS_ADD_LIBRARY( forteuchos diff --git a/src/teuchos/src/forteuchos.f90 b/src/teuchos/src/swig/forteuchos.f90 similarity index 100% rename from src/teuchos/src/forteuchos.f90 rename to src/teuchos/src/swig/forteuchos.f90 diff --git a/src/teuchos/src/forteuchosFORTRAN_wrap.cxx b/src/teuchos/src/swig/forteuchosFORTRAN_wrap.cxx similarity index 100% rename from src/teuchos/src/forteuchosFORTRAN_wrap.cxx rename to src/teuchos/src/swig/forteuchosFORTRAN_wrap.cxx diff --git a/src/tpetra/src/CMakeLists.txt b/src/tpetra/src/CMakeLists.txt index 1f4d1161..a56680ee 100644 --- a/src/tpetra/src/CMakeLists.txt +++ b/src/tpetra/src/CMakeLists.txt @@ -8,11 +8,11 @@ INCLUDE_DIRECTORIES(${CMAKE_CURRENT_BINARY_DIR}) IF (ForTrilinos_ENABLE_DeveloperMode) IF (ForTrilinos_EXPORT_SWIG) # Generate wrapper and proxy files since MPI is enabled - SET(CMAKE_SWIG_OUTDIR "${CMAKE_CURRENT_SOURCE_DIR}") + SET(CMAKE_SWIG_OUTDIR "${CMAKE_CURRENT_SOURCE_DIR}/swig") ENDIF() LIST(APPEND CMAKE_SWIG_FLAGS -I${CMAKE_CURRENT_SOURCE_DIR}/../../utils/src/) - MAKE_SWIG(MODULE fortpetra + MAKE_SWIG_FORTRAN(MODULE fortpetra SOURCE fortpetra.i DEPLIBS ${Trilinos_LIBRARIES} EXTRASRC ${EXTRA_SOURCE} @@ -20,8 +20,8 @@ IF (ForTrilinos_ENABLE_DeveloperMode) ELSE() # Use pre-generated files SET(GEN_SOURCE - fortpetra.f90 - fortpetraFORTRAN_wrap.cxx) + swig/fortpetra.f90 + swig/fortpetraFORTRAN_wrap.cxx) TRIBITS_ADD_LIBRARY( fortpetra diff --git a/src/tpetra/src/fortpetra.f90 b/src/tpetra/src/swig/fortpetra.f90 similarity index 100% rename from src/tpetra/src/fortpetra.f90 rename to src/tpetra/src/swig/fortpetra.f90 diff --git a/src/tpetra/src/fortpetraFORTRAN_wrap.cxx b/src/tpetra/src/swig/fortpetraFORTRAN_wrap.cxx similarity index 100% rename from src/tpetra/src/fortpetraFORTRAN_wrap.cxx rename to src/tpetra/src/swig/fortpetraFORTRAN_wrap.cxx diff --git a/src/utils/src/CMakeLists.txt b/src/utils/src/CMakeLists.txt index 352fbb76..e494dac5 100644 --- a/src/utils/src/CMakeLists.txt +++ b/src/utils/src/CMakeLists.txt @@ -8,18 +8,18 @@ INCLUDE_DIRECTORIES(${CMAKE_CURRENT_BINARY_DIR}) IF (ForTrilinos_ENABLE_DeveloperMode) IF (ForTrilinos_EXPORT_SWIG) # Generate wrapper and proxy files since MPI is enabled - SET(CMAKE_SWIG_OUTDIR "${CMAKE_CURRENT_SOURCE_DIR}") + SET(CMAKE_SWIG_OUTDIR "${CMAKE_CURRENT_SOURCE_DIR}/swig") ENDIF() - MAKE_SWIG(MODULE forerror + MAKE_SWIG_FORTRAN(MODULE forerror SOURCE forerror.i EXTRASRC ${EXTRA_SOURCE} ) ELSE() # Use pre-generated files SET(GEN_SOURCE - forerror.f90 - forerrorFORTRAN_wrap.cxx) + swig/forerror.f90 + swig/forerrorFORTRAN_wrap.cxx) TRIBITS_ADD_LIBRARY( forerror @@ -34,4 +34,3 @@ TRIBITS_ADD_LIBRARY( ) INSTALL(FILES ${CMAKE_CURRENT_SOURCE_DIR}/ForTrilinos.h DESTINATION include) -INSTALL(FILES ${CMAKE_CURRENT_BINARY_DIR}/forerror.mod DESTINATION include) diff --git a/src/utils/src/forerror.f90 b/src/utils/src/swig/forerror.f90 similarity index 100% rename from src/utils/src/forerror.f90 rename to src/utils/src/swig/forerror.f90 diff --git a/src/utils/src/forerrorFORTRAN_wrap.cxx b/src/utils/src/swig/forerrorFORTRAN_wrap.cxx similarity index 100% rename from src/utils/src/forerrorFORTRAN_wrap.cxx rename to src/utils/src/swig/forerrorFORTRAN_wrap.cxx From a5828133d93dddf15b817bd5c263f56c54c3e453 Mon Sep 17 00:00:00 2001 From: Seth R Johnson Date: Fri, 1 Feb 2019 11:56:10 -0500 Subject: [PATCH 03/40] Refactor SWIG cmake files for new cmake version --- CMakeLists.txt | 12 +- cmake/CheckSWIGFortran.cmake | 23 + cmake/SwigModules.cmake | 273 ++------ cmake/SwigModulesOld.cmake | 271 +++++++ cmake/UseSWIG/ManageSupportFiles.cmake | 31 + cmake/UseSWIGFortran.cmake | 816 ++++++++++++++++++++++ cmake/{UseSWIG.cmake => UseSWIGOld.cmake} | 0 src/teuchos/src/CMakeLists.txt | 6 +- 8 files changed, 1221 insertions(+), 211 deletions(-) create mode 100644 cmake/CheckSWIGFortran.cmake create mode 100644 cmake/SwigModulesOld.cmake create mode 100644 cmake/UseSWIG/ManageSupportFiles.cmake create mode 100644 cmake/UseSWIGFortran.cmake rename cmake/{UseSWIG.cmake => UseSWIGOld.cmake} (100%) diff --git a/CMakeLists.txt b/CMakeLists.txt index 9ad3c3fb..432e1b91 100644 --- a/CMakeLists.txt +++ b/CMakeLists.txt @@ -22,10 +22,18 @@ SET(CMAKE_Fortran_FLAGS "-ffree-line-length-none -cpp ${CMAKE_Fortran_FLAGS}") IF (${PACKAGE_NAME}_ENABLE_DeveloperMode) # SWIG setup FIND_PACKAGE(SWIG REQUIRED) - INCLUDE(SwigModules) + # SWIG is requested and available; make sure it's the Fortran fork. + INCLUDE(CheckSWIGFortran) + IF (CMAKE_VERSION VERSION_LESS 3.10) + # TODO: Old version of cmake modules + include(SwigModulesOld) + ELSE() + include(SwigModules) + ENDIF() + # Ignore some SWIG warnings: # 401: "Nothing known about base class" - SET(CMAKE_SWIG_FLAGS "-w401 ${CMAKE_SWIG_FLAGS}") + LIST(APPEND CMAKE_SWIG_FLAGS "-w401") IF (NOT TPL_ENABLE_MPI) # Warn if MPI is disabled since not all wrapper functions will be diff --git a/cmake/CheckSWIGFortran.cmake b/cmake/CheckSWIGFortran.cmake new file mode 100644 index 00000000..6083fe86 --- /dev/null +++ b/cmake/CheckSWIGFortran.cmake @@ -0,0 +1,23 @@ +include(UseSWIG) + +set(SWIG_FORTRAN_EXTRA_FILE_EXTENSIONS ".f90") + +# Check that SWIG has been found +if (NOT SWIG_EXECUTABLE) + message(FATAL_ERROR "SWIG is not available.") +endif() + +# Make sure it's the branch that actually supports Fortran +if (NOT SWIG_CHECKED_FORTRAN) + execute_process(COMMAND ${SWIG_EXECUTABLE} -help + OUTPUT_VARIABLE SWIG_help_output + ERROR_VARIABLE SWIG_help_output + RESULT_VARIABLE SWIG_help_result) + if (NOT SWIG_help_output MATCHES "Fortran") + message(FATAL_ERROR "This version of SWIG does not support Fortran " + "wrapping. Please install the version from " + "https://github.com/sethrj/swig") + endif() + set(SWIG_CHECKED_FORTRAN TRUE CACHE INTERNAL "") +endif() + diff --git a/cmake/SwigModules.cmake b/cmake/SwigModules.cmake index e6b85574..7b14a3e5 100644 --- a/cmake/SwigModules.cmake +++ b/cmake/SwigModules.cmake @@ -1,68 +1,19 @@ -############################################################################## -# File : SwigModules.cmake -# Author: Seth Johnson -# Date : Wednesday July 18 17:5:36 2012 -#----------------------------------------------------------------------------# -# Copyright (C) 2012 Oak Ridge National Laboratory, UT-Battelle, LLC. -############################################################################## - -IF (NOT DEFINED SWIG_DIR) - MESSAGE(FATAL_ERROR "SWIG not loaded.") -ENDIF() - -# Load SWIG and other modules we need -INCLUDE(UseSWIG) -INCLUDE(CMakeParseArguments) -INCLUDE(CheckCXXCompilerFlag) - -# Tell SWIG to use modern Python code -LIST(APPEND CMAKE_SWIG_PYTHON_FLAGS "-modern" "-noproxydel") - -# If python version is high enough, add -py3 flag -IF(PYTHON_VERSION_STRING VERSION_GREATER 3.0) - LIST(APPEND CMAKE_SWIG_PYTHON_FLAGS "-py3") -ENDIF() - -# Define extra output files -set(SWIG_FORTRAN_EXTRA_FILE_EXTENSIONS ".f90")# new CMake - -##---------------------------------------------------------------------------## -# Look through a header/SWIG file and find dependencies - -MACRO(get_swig_dependencies _RESULT_VAR _SOURCE) - # Search for dependencies in the SWIG file - FILE(STRINGS ${_SOURCE} HEADER_FILES - REGEX "^[ \t]*%include *\"" - ) - LIST(REMOVE_DUPLICATES HEADER_FILES) - - # Set up test directories - SET(TEST_DIRS - ${CMAKE_CURRENT_SOURCE_DIR} - ) - - # Get just the file names inside each "include" - SET(${_RESULT_VAR}) - FOREACH(THEFILE ${HEADER_FILES}) - STRING(REGEX REPLACE "^.*\"([^\"]+)\".*$" "\\1" THEFILE ${THEFILE}) - IF( THEFILE ) - FOREACH(TESTDIR ${TEST_DIRS}) - IF(EXISTS ${TESTDIR}/${THEFILE}) - LIST(APPEND ${_RESULT_VAR} ${TESTDIR}/${THEFILE}) - BREAK() - ENDIF() - ENDFOREACH() - ENDIF() - ENDFOREACH() -ENDMACRO() +set(UseSWIG_MODULE_VERSION 2) +if (CMAKE_VERSION VERSION_LESS 3.20) + # TODO: This is until Fortran support gets added to the upstream cmake script + include(UseSWIGFortran) +else() + cmake_policy(SET CMP0078 "NEW") + cmake_policy(SET CMP0086 "NEW") + include(UseSWIG) +endif() ##---------------------------------------------------------------------------## ## ADDING SWIG MODULES ##---------------------------------------------------------------------------## -# MAKE_SWIG( +# MAKE_SWIG_FORTRAN( # MODULE module # [C] -# [LANGUAGE fortran] # [SOURCE src.i] # [DEPLIBS lib1 [lib2 ...]] # [DEPMODULES module1 [module2 ...]] @@ -86,31 +37,21 @@ ENDMACRO() # The EXTRASRC argument allows additional sources to be compiled into the SWIG # module target. -function(MAKE_SWIG) +function(MAKE_SWIG_FORTRAN) cmake_parse_arguments(PARSE "C" "MODULE;LANGUAGE;SOURCE" "DEPLIBS;DEPMODULES;EXTRASRC" ${ARGN}) - if(NOT PARSE_MODULE) + if (NOT PARSE_MODULE) message(SEND_ERROR "Cannot call MAKE_SWIG without MODULE") endif() set(PARSE_MODULE ${PARSE_MODULE}) - if(NOT PARSE_LANGUAGE) - SET(PARSE_LANGUAGE FORTRAN) - endif() - string(TOUPPER "${PARSE_LANGUAGE}" PARSE_LANGUAGE) - - if(PARSE_SOURCE) + if (PARSE_SOURCE) set(SRC_FILE "${PARSE_SOURCE}") else() set(SRC_FILE "${PARSE_MODULE}.i") endif() - if(NOT CMAKE_SWIG_OUTDIR) - # XXX: turn this into an option passed into the function - set(CMAKE_SWIG_OUTDIR "${CMAKE_CURRENT_BINARY_DIR}") - endif() - # Let SWIG know that we're compiling C++ files, and what the module is set_source_files_properties(${SRC_FILE} PROPERTIES SWIG_MODULE_NAME ${PARSE_MODULE}) @@ -120,145 +61,69 @@ function(MAKE_SWIG) CPLUSPLUS TRUE) endif() - IF ("${CMAKE_VERSION}" VERSION_LESS "3.11.0") - # Get dependencies of main SWIG source file and the files it includes. - # A similar feature was integrated into SWIG: - # https://gitlab.kitware.com/cmake/cmake/merge_requests/354 - set(SUBDEPS ${SRC_FILE}) - set(DEPENDENCIES) - foreach(RECURSION 0 1 2) - set(OLD_SUBDEPS ${SUBDEPS}) - set(SUBDEPS) - foreach(DEPENDENCY ${OLD_SUBDEPS}) - if(DEPENDENCY MATCHES "\\.i$") - get_swig_dependencies(SUBSUBDEPS ${DEPENDENCY}) - list(APPEND SUBDEPS ${SUBSUBDEPS}) - endif() - endforeach() - list(APPEND DEPENDENCIES ${SUBDEPS}) - endforeach() - - message("Extra dependencies for ${SRC_FILE}:\n ${DEPENDENCIES}" ) - set(SWIG_MODULE_${PARSE_MODULE}_EXTRA_DEPS ${DEPENDENCIES} ) - ENDIF() - - if (PARSE_LANGUAGE STREQUAL "FORTRAN") - set(SWIG_FORTRAN_GENERATED_SRC "${CMAKE_SWIG_OUTDIR}/${PARSE_MODULE}.f90") - # Usually SWIG wrapper libraries need to be built as shared libraries that - # are never linked into the CMake dependencies themselves (the "MODULE" - # type); not the case with fortran. This relies on the patched UseSWIG. - if(BUILD_SHARED_LIBS) - set(SWIG_LIBRARY_TYPE SHARED) - else() - set(SWIG_LIBRARY_TYPE STATIC) - endif() - else() - set(SWIG_LIBRARY_TYPE MODULE) - endif() - - # Set up compiler flags - set(_ORIG_CMAKE_SWIG_FLAGS ${CMAKE_SWIG_FLAGS}) - list(APPEND CMAKE_SWIG_FLAGS "${CMAKE_SWIG_${PARSE_LANGUAGE}_FLAGS}") - - # Create the SWIG module - if (DEFINED TRIBITS_CMAKE_MINIMUM_REQUIRED AND PARSE_LANGUAGE STREQUAL "FORTRAN") - # Special case for Tribits build systems is needed to propagate includes, - # rpaths, etc. - - # XXX hack to set up link/include directories BEFORE the call to - # TRIBITS_ADD_LIBRARY - TRIBITS_SORT_AND_APPEND_PACKAGE_INCLUDE_AND_LINK_DIRS_AND_LIBS( - ${PACKAGE_NAME} LIB LINK_LIBS) - - TRIBITS_SORT_AND_APPEND_TPL_INCLUDE_AND_LINK_DIRS_AND_LIBS( - ${PACKAGE_NAME} LIB LINK_LIBS) - - PRINT_VAR(${PACKAGE_NAME}_INCLUDE_DIRS) - # # Add TriBITS include directories to the SWIG commands (because the - # # add_library call comes after the SWIG creation, the "include_directories" - # # command hasn't been called at this point.) - # FOREACH(dir ${${PACKAGE_NAME}_INCLUDE_DIRS}) - # LIST(APPEND CMAKE_SWIG_FLAGS "-I${dir}") - # ENDFOREACH() - - # Generate the SWIG commands and targets - SWIG_MODULE_INITIALIZE(${PARSE_MODULE} ${PARSE_LANGUAGE}) - SWIG_ADD_SOURCE_TO_MODULE(${PARSE_MODULE} swig_wrapper_src ${SRC_FILE}) - get_directory_property(swig_extra_clean_files ADDITIONAL_MAKE_CLEAN_FILES) - list(APPEND swig_extra_clean_files "${swig_wrapper_src}" - "${SWIG_FORTRAN_GENERATED_SRC}") - set_directory_properties(PROPERTIES ADDITIONAL_MAKE_CLEAN_FILES - "${swig_extra_clean_files}") - - # Add as a TriBITS library - TRIBITS_ADD_LIBRARY(${PARSE_MODULE} - SOURCES ${PARSE_EXTRASRC} - ${SWIG_FORTRAN_GENERATED_SRC} - ${swig_wrapper_src}) - else() - swig_add_library(${PARSE_MODULE} - LANGUAGE ${PARSE_LANGUAGE} - TYPE ${SWIG_LIBRARY_TYPE} - SOURCES ${SRC_FILE} ${SWIG_FORTRAN_GENERATED_SRC} ${PARSE_EXTRASRC}) - endif() - - # Restore original SWIG flags - SET(CMAKE_SWIG_FLAGS _ORIG_CMAKE_SWIG_FLAGS) - - # Mangled name of the SWIG target (export to parent) - set(BUILT_LIBRARY ${SWIG_MODULE_${PARSE_MODULE}_REAL_NAME}) - set(SWIG_MODULE_${PARSE_MODULE}_REAL_NAME ${BUILT_LIBRARY} PARENT_SCOPE) - - # It's not always necessary to link against python libraries, but doing so - # can turn unfortunate run-time errors (dlopen) into link-time errors. - if(PARSE_LANGUAGE STREQUAL "PYTHON" AND ${CMAKE_SYSTEM_NAME} MATCHES "Darwin") - if(NOT ${PYTHON_LIBRARIES} MATCHES ".framework") - # Turn off undefined symbol errors on Mac systems where - # Python is not installed as a framework - # see http://bugs.python.org/issue1602133 about _initposix issues - set_target_properties(${BUILT_LIBRARY} - PROPERTIES LINK_FLAGS "-undefined suppress -flat_namespace") - else() - # Otherwise, link against Python libraries - swig_link_libraries(${PARSE_MODULE} ${PYTHON_LIBRARIES}) - endif() - endif() + # UseSWIG with "NEW" policy creates a target with the same name as the first + # argument to swig_add_library. + set(LIBRARY_NAME ${PARSE_MODULE}) + swig_add_library(${LIBRARY_NAME} + LANGUAGE Fortran + TYPE USE_BUILD_SHARED_LIBS + SOURCES ${SRC_FILE} ${PARSE_EXTRASRC}) # Link against other dependent libraries - IF (PARSE_DEPLIBS) - target_link_libraries(${BUILT_LIBRARY} ${PARSE_DEPLIBS}) - ENDIF() - - # Add intra-module dependencies + if (PARSE_DEPLIBS) + target_link_libraries(${LIBRARY_NAME} ${PARSE_DEPLIBS}) + endif() foreach(DEPMODULE ${PARSE_DEPMODULES}) - add_dependencies(${BUILT_LIBRARY} _${DEPMODULE}) + add_dependencies(${LIBRARY_NAME} ${DEPMODULE}) endforeach() - - # Include the Python directory and current source directory for the SWIG - # targets (SWIG processor and compilation of the resulting CXX file.) We don't - # use the INCLUDE_DIRECTORIES command because because TriBITS will - # propagate the path if we use INCLUDE_DIRECTORIES. - # Apply SWIG_CXX_FLAGS to hide warnings and such. - get_target_property(INCL_DIR ${BUILT_LIBRARY} INCLUDE_DIRECTORIES) - IF(NOT INCL_DIR) - SET(INCL_DIR "") - ENDIF() - list(APPEND INCL_DIR ${CMAKE_CURRENT_SOURCE_DIR}) - if (PARSE_LANGUAGE STREQUAL "PYTHON") - list(APPEND INCL_DIR ${PYTHON_INCLUDE_DIRS}) + set(LINK_LIBS) +# XXX From TribitsLibraryMacros + TRIBITS_SORT_AND_APPEND_PACKAGE_INCLUDE_AND_LINK_DIRS_AND_LIBS( + ${PACKAGE_NAME} LIB LINK_LIBS) + + TRIBITS_SORT_AND_APPEND_TPL_INCLUDE_AND_LINK_DIRS_AND_LIBS( + ${PACKAGE_NAME} LIB LINK_LIBS) +# XXX END + + # Set properties on the target. + get_target_property(INCL_DIR ${LIBRARY_NAME} INCLUDE_DIRECTORIES) + if (NOT INCL_DIR) + set(INCL_DIR) endif() + list(APPEND INCL_DIR ${CMAKE_CURRENT_SOURCE_DIR} ${CMAKE_CURRENT_BINARY_DIR}) list(REMOVE_DUPLICATES INCL_DIR) - set_target_properties(${BUILT_LIBRARY} PROPERTIES - INCLUDE_DIRECTORIES "${INCL_DIR}" + set_target_properties(${LIBRARY_NAME} PROPERTIES + SWIG_INCLUDE_DIRECTORIES "${INCL_DIR}" COMPILE_FLAGS "${SWIG_CXX_FLAGS}") + target_link_libraries(${LIBRARY_NAME} ${LINK_LIBS}) + +# XXX From TribitsLibraryMacros + # Add to tribits library list + SET_PROPERTY( + TARGET ${LIBRARY_NAME} + APPEND PROPERTY + LABELS ${PACKAGE_NAME}Libs ${PARENT_PACKAGE_NAME}Libs + ) + PREPEND_GLOBAL_SET(${PARENT_PACKAGE_NAME}_LIB_TARGETS ${LIBRARY_NAME}) + PREPEND_GLOBAL_SET(${PARENT_PACKAGE_NAME}_ALL_TARGETS ${LIBRARY_NAME}) + INSTALL( + TARGETS ${LIBRARY_NAME} + EXPORT ${PACKAGE_NAME} + RUNTIME DESTINATION "${${PROJECT_NAME}_INSTALL_RUNTIME_DIR}" + LIBRARY DESTINATION "${${PROJECT_NAME}_INSTALL_LIB_DIR}" + ARCHIVE DESTINATION "${${PROJECT_NAME}_INSTALL_LIB_DIR}" + COMPONENT ${PACKAGE_NAME} + ) + PREPEND_GLOBAL_SET(${PACKAGE_NAME}_INCLUDE_DIRS ${INCL_DIR}) + PREPEND_GLOBAL_SET(${PACKAGE_NAME}_LIBRARY_DIRS ${INCL_DIR}) + PREPEND_GLOBAL_SET(${PACKAGE_NAME}_LIBRARIES ${LIBRARY_NAME}) - # message(STATUS "Include directories on target ${PARSE_MODULE}: ${INCL_DIR}") + GLOBAL_SET(${PACKAGE_NAME}_HAS_NATIVE_LIBRARIES TRUE) +# XXX END TriBits - # define the install targets - if (PARSE_LANGUAGE STREQUAL "PYTHON") - install(TARGETS ${BUILT_LIBRARY} - DESTINATION python) - install(FILES ${CMAKE_SWIG_OUTDIR}/${PARSE_MODULE}.py - DESTINATION python) - endif () + # Install the built target module + install(FILES ${CMAKE_CURRENT_BINARY_DIR}/${PARSE_MODULE}.mod + DESTINATION include) endfunction() + + diff --git a/cmake/SwigModulesOld.cmake b/cmake/SwigModulesOld.cmake new file mode 100644 index 00000000..3a0f59dc --- /dev/null +++ b/cmake/SwigModulesOld.cmake @@ -0,0 +1,271 @@ +############################################################################## +# File : SwigModulesOld.cmake +# Author: Seth Johnson +# Date : Wednesday July 18 17:5:36 2012 +#----------------------------------------------------------------------------# +# Copyright (C) 2012 Oak Ridge National Laboratory, UT-Battelle, LLC. +############################################################################## + +IF (NOT DEFINED SWIG_DIR) + MESSAGE(FATAL_ERROR "SWIG not loaded.") +ENDIF() + +# Load SWIG and other modules we need +INCLUDE(UseSWIGOld) +INCLUDE(CMakeParseArguments) +INCLUDE(CheckCXXCompilerFlag) + +# Tell SWIG to use modern Python code +LIST(APPEND CMAKE_SWIG_PYTHON_FLAGS "-modern" "-noproxydel") + +# If python version is high enough, add -py3 flag +IF(PYTHON_VERSION_STRING VERSION_GREATER 3.0) + LIST(APPEND CMAKE_SWIG_PYTHON_FLAGS "-py3") +ENDIF() + +# Define extra output files +set(SWIG_FORTRAN_EXTRA_FILE_EXTENSIONS ".f90")# new CMake + +##---------------------------------------------------------------------------## +# Look through a header/SWIG file and find dependencies + +MACRO(get_swig_dependencies _RESULT_VAR _SOURCE) + # Search for dependencies in the SWIG file + FILE(STRINGS ${_SOURCE} HEADER_FILES + REGEX "^[ \t]*%include *\"" + ) + LIST(REMOVE_DUPLICATES HEADER_FILES) + + # Set up test directories + SET(TEST_DIRS + ${CMAKE_CURRENT_SOURCE_DIR} + ) + + # Get just the file names inside each "include" + SET(${_RESULT_VAR}) + FOREACH(THEFILE ${HEADER_FILES}) + STRING(REGEX REPLACE "^.*\"([^\"]+)\".*$" "\\1" THEFILE ${THEFILE}) + IF( THEFILE ) + FOREACH(TESTDIR ${TEST_DIRS}) + IF(EXISTS ${TESTDIR}/${THEFILE}) + LIST(APPEND ${_RESULT_VAR} ${TESTDIR}/${THEFILE}) + BREAK() + ENDIF() + ENDFOREACH() + ENDIF() + ENDFOREACH() +ENDMACRO() + +##---------------------------------------------------------------------------## +## ADDING SWIG MODULES +##---------------------------------------------------------------------------## +# MAKE_SWIG( +# MODULE module +# [C] +# [LANGUAGE fortran] +# [SOURCE src.i] +# [DEPLIBS lib1 [lib2 ...]] +# [DEPMODULES module1 [module2 ...]] +# [EXTRASRC file1 [file2 ...]] +# ) +# +# Create a SWIG-generated python module and shared object. +# +# Add the [C] flag if the input is to be treated as a C wrapper rather than C++. +# +# The MODULE argument is the name of the resulting module file. By default it +# assumes the name "module.i", but that can be overriden with the SOURCE +# argument. +# +# All libraries in DEPLIBS will be linked against each target. +# +# All other module names in DEPMODULES will be separately added as dependencies +# without being linked. This is used for TriBITS, which understands the +# inter-library linkages but not SWIG modules. +# +# The EXTRASRC argument allows additional sources to be compiled into the SWIG +# module target. + +function(MAKE_SWIG) + cmake_parse_arguments(PARSE "C" "MODULE;LANGUAGE;SOURCE" + "DEPLIBS;DEPMODULES;EXTRASRC" ${ARGN}) + + if(NOT PARSE_MODULE) + message(SEND_ERROR "Cannot call MAKE_SWIG without MODULE") + endif() + set(PARSE_MODULE ${PARSE_MODULE}) + + if(NOT PARSE_LANGUAGE) + SET(PARSE_LANGUAGE FORTRAN) + endif() + string(TOUPPER "${PARSE_LANGUAGE}" PARSE_LANGUAGE) + + if(PARSE_SOURCE) + set(SRC_FILE "${PARSE_SOURCE}") + else() + set(SRC_FILE "${PARSE_MODULE}.i") + endif() + + if(NOT CMAKE_SWIG_OUTDIR) + # XXX: turn this into an option passed into the function + set(CMAKE_SWIG_OUTDIR "${CMAKE_CURRENT_BINARY_DIR}") + endif() + + # Let SWIG know that we're compiling C++ files, and what the module is + set_source_files_properties(${SRC_FILE} PROPERTIES + SWIG_MODULE_NAME ${PARSE_MODULE}) + + if (NOT PARSE_C) + set_source_files_properties(${SRC_FILE} PROPERTIES + CPLUSPLUS TRUE) + endif() + + IF ("${CMAKE_VERSION}" VERSION_LESS "3.11.0") + # Get dependencies of main SWIG source file and the files it includes. + # A similar feature was integrated into SWIG: + # https://gitlab.kitware.com/cmake/cmake/merge_requests/354 + set(SUBDEPS ${SRC_FILE}) + set(DEPENDENCIES) + foreach(RECURSION 0 1 2) + set(OLD_SUBDEPS ${SUBDEPS}) + set(SUBDEPS) + foreach(DEPENDENCY ${OLD_SUBDEPS}) + if(DEPENDENCY MATCHES "\\.i$") + get_swig_dependencies(SUBSUBDEPS ${DEPENDENCY}) + list(APPEND SUBDEPS ${SUBSUBDEPS}) + endif() + endforeach() + list(APPEND DEPENDENCIES ${SUBDEPS}) + endforeach() + + message("Extra dependencies for ${SRC_FILE}:\n ${DEPENDENCIES}" ) + set(SWIG_MODULE_${PARSE_MODULE}_EXTRA_DEPS ${DEPENDENCIES} ) + ENDIF() + + if (PARSE_LANGUAGE STREQUAL "FORTRAN") + set(SWIG_FORTRAN_GENERATED_SRC "${CMAKE_SWIG_OUTDIR}/${PARSE_MODULE}.f90") + # Usually SWIG wrapper libraries need to be built as shared libraries that + # are never linked into the CMake dependencies themselves (the "MODULE" + # type); not the case with fortran. This relies on the patched UseSWIG. + if(BUILD_SHARED_LIBS) + set(SWIG_LIBRARY_TYPE SHARED) + else() + set(SWIG_LIBRARY_TYPE STATIC) + endif() + else() + set(SWIG_LIBRARY_TYPE MODULE) + endif() + + # Set up compiler flags + set(_ORIG_CMAKE_SWIG_FLAGS ${CMAKE_SWIG_FLAGS}) + list(APPEND CMAKE_SWIG_FLAGS "${CMAKE_SWIG_${PARSE_LANGUAGE}_FLAGS}") + + # Create the SWIG module + if (DEFINED TRIBITS_CMAKE_MINIMUM_REQUIRED AND PARSE_LANGUAGE STREQUAL "FORTRAN") + # Special case for Tribits build systems is needed to propagate includes, + # rpaths, etc. + + # XXX hack to set up link/include directories BEFORE the call to + # TRIBITS_ADD_LIBRARY + TRIBITS_SORT_AND_APPEND_PACKAGE_INCLUDE_AND_LINK_DIRS_AND_LIBS( + ${PACKAGE_NAME} LIB LINK_LIBS) + + TRIBITS_SORT_AND_APPEND_TPL_INCLUDE_AND_LINK_DIRS_AND_LIBS( + ${PACKAGE_NAME} LIB LINK_LIBS) + + PRINT_VAR(${PACKAGE_NAME}_INCLUDE_DIRS) + # # Add TriBITS include directories to the SWIG commands (because the + # # add_library call comes after the SWIG creation, the "include_directories" + # # command hasn't been called at this point.) + # FOREACH(dir ${${PACKAGE_NAME}_INCLUDE_DIRS}) + # LIST(APPEND CMAKE_SWIG_FLAGS "-I${dir}") + # ENDFOREACH() + + # Generate the SWIG commands and targets + SWIG_MODULE_INITIALIZE(${PARSE_MODULE} ${PARSE_LANGUAGE}) + SWIG_ADD_SOURCE_TO_MODULE(${PARSE_MODULE} swig_wrapper_src ${SRC_FILE}) + get_directory_property(swig_extra_clean_files ADDITIONAL_MAKE_CLEAN_FILES) + list(APPEND swig_extra_clean_files "${swig_wrapper_src}" + "${SWIG_FORTRAN_GENERATED_SRC}") + set_directory_properties(PROPERTIES ADDITIONAL_MAKE_CLEAN_FILES + "${swig_extra_clean_files}") + + # Add as a TriBITS library + TRIBITS_ADD_LIBRARY(${PARSE_MODULE} + SOURCES ${PARSE_EXTRASRC} + ${SWIG_FORTRAN_GENERATED_SRC} + ${swig_wrapper_src}) + else() + swig_add_library(${PARSE_MODULE} + LANGUAGE ${PARSE_LANGUAGE} + TYPE ${SWIG_LIBRARY_TYPE} + SOURCES ${SRC_FILE} ${SWIG_FORTRAN_GENERATED_SRC} ${PARSE_EXTRASRC}) + endif() + + # Restore original SWIG flags + SET(CMAKE_SWIG_FLAGS _ORIG_CMAKE_SWIG_FLAGS) + + # Mangled name of the SWIG target (export to parent) + set(LIBRARY_NAME ${SWIG_MODULE_${PARSE_MODULE}_REAL_NAME}) + set(SWIG_MODULE_${PARSE_MODULE}_REAL_NAME ${LIBRARY_NAME} PARENT_SCOPE) + + # It's not always necessary to link against python libraries, but doing so + # can turn unfortunate run-time errors (dlopen) into link-time errors. + if(PARSE_LANGUAGE STREQUAL "PYTHON" AND ${CMAKE_SYSTEM_NAME} MATCHES "Darwin") + if(NOT ${PYTHON_LIBRARIES} MATCHES ".framework") + # Turn off undefined symbol errors on Mac systems where + # Python is not installed as a framework + # see http://bugs.python.org/issue1602133 about _initposix issues + set_target_properties(${LIBRARY_NAME} + PROPERTIES LINK_FLAGS "-undefined suppress -flat_namespace") + else() + # Otherwise, link against Python libraries + swig_link_libraries(${PARSE_MODULE} ${PYTHON_LIBRARIES}) + endif() + endif() + + # Link against other dependent libraries + IF (PARSE_DEPLIBS) + target_link_libraries(${LIBRARY_NAME} ${PARSE_DEPLIBS}) + ENDIF() + + # Add intra-module dependencies + foreach(DEPMODULE ${PARSE_DEPMODULES}) + add_dependencies(${LIBRARY_NAME} _${DEPMODULE}) + endforeach() + + # Include the Python directory and current source directory for the SWIG + # targets (SWIG processor and compilation of the resulting CXX file.) We don't + # use the INCLUDE_DIRECTORIES command because because TriBITS will + # propagate the path if we use INCLUDE_DIRECTORIES. + # Apply SWIG_CXX_FLAGS to hide warnings and such. + get_target_property(INCL_DIR ${LIBRARY_NAME} INCLUDE_DIRECTORIES) + IF(NOT INCL_DIR) + SET(INCL_DIR "") + ENDIF() + list(APPEND INCL_DIR ${CMAKE_CURRENT_SOURCE_DIR}) + if (PARSE_LANGUAGE STREQUAL "PYTHON") + list(APPEND INCL_DIR ${PYTHON_INCLUDE_DIRS}) + endif() + list(REMOVE_DUPLICATES INCL_DIR) + set_target_properties(${LIBRARY_NAME} PROPERTIES + INCLUDE_DIRECTORIES "${INCL_DIR}" + COMPILE_FLAGS "${SWIG_CXX_FLAGS}") + + # message(STATUS "Include directories on target ${PARSE_MODULE}: ${INCL_DIR}") + + # define the install targets + if (PARSE_LANGUAGE STREQUAL "PYTHON") + install(TARGETS ${LIBRARY_NAME} + DESTINATION python) + install(FILES ${CMAKE_SWIG_OUTDIR}/${PARSE_MODULE}.py + DESTINATION python) + elseif (PARSE_LANGUAGE STREQUAL "PYTHON") + install(TARGETS ${CMAKE_CURRENT_BINARY_DIR}/${PARSE_MODULE}.mod + DESTINATION include) + endif () +endfunction() + +macro(MAKE_SWIG_FORTRAN) + MAKE_SWIG(${ARGN} LANGUAGE Fortran) +endmacro() diff --git a/cmake/UseSWIG/ManageSupportFiles.cmake b/cmake/UseSWIG/ManageSupportFiles.cmake new file mode 100644 index 00000000..4a03900b --- /dev/null +++ b/cmake/UseSWIG/ManageSupportFiles.cmake @@ -0,0 +1,31 @@ +# Distributed under the OSI-approved BSD 3-Clause License. See accompanying +# file Copyright.txt or https://cmake.org/licensing for details. + + +if (ACTION STREQUAL "CLEAN") + # Collect current list of generated files + file (GLOB files LIST_DIRECTORIES FALSE RELATIVE "${SUPPORT_FILES_WORKING_DIRECTORY}" "${SUPPORT_FILES_WORKING_DIRECTORY}/*") + + if (files) + # clean-up the output directory + ## compute full paths + list (TRANSFORM files PREPEND "${SUPPORT_FILES_OUTPUT_DIRECTORY}/") + ## remove generated files from the output directory + file (REMOVE ${files}) + + # clean-up working directory + file (REMOVE_RECURSE "${SUPPORT_FILES_WORKING_DIRECTORY}") + endif() + + file (MAKE_DIRECTORY "${SUPPORT_FILES_WORKING_DIRECTORY}") +endif() + +if (ACTION STREQUAL "COPY") + # Collect current list of generated files + file (GLOB files LIST_DIRECTORIES FALSE "${SUPPORT_FILES_WORKING_DIRECTORY}/*") + + if (files) + # copy files to the output directory + file (COPY ${files} DESTINATION "${SUPPORT_FILES_OUTPUT_DIRECTORY}") + endif() +endif() diff --git a/cmake/UseSWIGFortran.cmake b/cmake/UseSWIGFortran.cmake new file mode 100644 index 00000000..8c0dc98d --- /dev/null +++ b/cmake/UseSWIGFortran.cmake @@ -0,0 +1,816 @@ +# Distributed under the OSI-approved BSD 3-Clause License. See accompanying +# file Copyright.txt or https://cmake.org/licensing for details. + +#[=======================================================================[.rst: +UseSWIG +------- + +This file provides support for ``SWIG``. It is assumed that :module:`FindSWIG` +module has already been loaded. + +Defines the following command for use with ``SWIG``: + +.. command:: swig_add_library + + Define swig module with given name and specified language:: + + swig_add_library( + [TYPE ] + LANGUAGE + [NO_PROXY] + [OUTPUT_DIR ] + [OUTFILE_DIR ] + SOURCES ... + ) + + Targets created with the ``swig_add_library`` command have the same + capabilities as targets created with the :command:`add_library` command, so + those targets can be used with any command expecting a target (e.g. + :command:`target_link_libraries`). + + .. note:: + + This command creates a target with the specified ```` when + policy :policy:`CMP0078` is set to ``NEW``. Otherwise, the legacy + behavior will choose a different target name and store it in the + ``SWIG_MODULE__REAL_NAME`` variable. + + .. note:: + + For multi-config generators, this module does not support + configuration-specific files generated by ``SWIG``. All build + configurations must result in the same generated source file. + + ``TYPE`` + ``SHARED``, ``MODULE`` and ``STATIC`` have the same semantic as for the + :command:`add_library` command. If ``USE_BUILD_SHARED_LIBS`` is specified, + the library type will be ``STATIC`` or ``SHARED`` based on whether the + current value of the :variable:`BUILD_SHARED_LIBS` variable is ``ON``. If + no type is specified, ``MODULE`` will be used. + + ``LANGUAGE`` + Specify the target language. + + ``NO_PROXY`` + Prevent the generation of the wrapper layer (swig ``-noproxy`` option). + + ``OUTPUT_DIR`` + Specify where to write the language specific files (swig ``-outdir`` + option). If not given, the ``CMAKE_SWIG_OUTDIR`` variable will be used. + If neither is specified, the default depends on the value of the + ``UseSWIG_MODULE_VERSION`` variable as follows: + + * If ``UseSWIG_MODULE_VERSION`` is 1 or is undefined, output is written to + the :variable:`CMAKE_CURRENT_BINARY_DIR` directory. + * If ``UseSWIG_MODULE_VERSION`` is 2, a dedicated directory will be used. + The path of this directory can be retrieved from the + ``SWIG_SUPPORT_FILES_DIRECTORY`` target property. + + ``OUTFILE_DIR`` + Specify an output directory name where the generated source file will be + placed (swig -o option). If not specified, the ``SWIG_OUTFILE_DIR`` variable + will be used. If neither is specified, ``OUTPUT_DIR`` or + ``CMAKE_SWIG_OUTDIR`` is used instead. + + ``SOURCES`` + List of sources for the library. Files with extension ``.i`` will be + identified as sources for the ``SWIG`` tool. Other files will be handled in + the standard way. This behavior can be overriden by specifying the variable + ``SWIG_SOURCE_FILE_EXTENSIONS``. + + .. note:: + + If ``UseSWIG_MODULE_VERSION`` is set to 2, it is **strongly** recommended + to use a dedicated directory unique to the target when either the + ``OUTPUT_DIR`` option or the ``CMAKE_SWIG_OUTDIR`` variable are specified. + The output directory contents are erased as part of the target build, so + to prevent interference between targets or losing other important files, + each target should have its own dedicated output directory. + +.. command:: swig_link_libraries + + Link libraries to swig module:: + + swig_link_libraries( ...) + + This command has same capabilities as :command:`target_link_libraries` + command. + + .. note:: + + If variable ``UseSWIG_TARGET_NAME_PREFERENCE`` is set to ``STANDARD``, this + command is deprecated and :command:`target_link_libraries` command must be + used instead. + +Source file properties on module files **must** be set before the invocation +of the ``swig_add_library`` command to specify special behavior of SWIG and +ensure generated files will receive the required settings. + +``CPLUSPLUS`` + Call SWIG in c++ mode. For example: + + .. code-block:: cmake + + set_property(SOURCE mymod.i PROPERTY CPLUSPLUS ON) + swig_add_library(mymod LANGUAGE python SOURCES mymod.i) + +``INCLUDE_DIRECTORIES``, ``COMPILE_DEFINITIONS`` and ``COMPILE_OPTIONS`` + Add custom flags to SWIG compiler and have same semantic as properties + :prop_sf:`INCLUDE_DIRECTORIES`, :prop_sf:`COMPILE_DEFINITIONS` and + :prop_sf:`COMPILE_OPTIONS`. + +``USE_TARGET_INCLUDE_DIRECTORIES`` + If set to ``TRUE``, contents of target property + :prop_tgt:`INCLUDE_DIRECTORIES` will be forwarded to ``SWIG`` compiler. + If set to ``FALSE`` target property :prop_tgt:`INCLUDE_DIRECTORIES` will be + ignored. If not set, target property ``SWIG_USE_TARGET_INCLUDE_DIRECTORIES`` + will be considered. + +``GENERATED_INCLUDE_DIRECTORIES``, ``GENERATED_COMPILE_DEFINITIONS`` and ``GENERATED_COMPILE_OPTIONS`` + Add custom flags to the C/C++ generated source. They will fill, respectively, + properties :prop_sf:`INCLUDE_DIRECTORIES`, :prop_sf:`COMPILE_DEFINITIONS` and + :prop_sf:`COMPILE_OPTIONS` of generated C/C++ file. + +``DEPENDS`` + Specify additional dependencies to the source file. + +``SWIG_MODULE_NAME`` + Specify the actual import name of the module in the target language. + This is required if it cannot be scanned automatically from source + or different from the module file basename. For example: + + .. code-block:: cmake + + set_property(SOURCE mymod.i PROPERTY SWIG_MODULE_NAME mymod_realname) + + .. note:: + + If policy :policy:`CMP0086` is set to ``NEW``, ``-module `` + is passed to ``SWIG`` compiler. + +Target library properties can be set to apply same configuration to all SWIG +input files. + +``SWIG_INCLUDE_DIRECTORIES``, ``SWIG_COMPILE_DEFINITIONS`` and ``SWIG_COMPILE_OPTIONS`` + These properties will be applied to all SWIG input files and have same + semantic as target properties :prop_tgt:`INCLUDE_DIRECTORIES`, + :prop_tgt:`COMPILE_DEFINITIONS` and :prop_tgt:`COMPILE_OPTIONS`. + + .. code-block:: cmake + + set (UseSWIG_TARGET_NAME_PREFERENCE STANDARD) + swig_add_library(mymod LANGUAGE python SOURCES mymod.i) + set_property(TARGET mymod PROPERTY SWIG_COMPILE_DEFINITIONS MY_DEF1 MY_DEF2) + set_property(TARGET mymod PROPERTY SWIG_COMPILE_OPTIONS -bla -blb) + +``SWIG_USE_TARGET_INCLUDE_DIRECTORIES`` + If set to ``TRUE``, contents of target property + :prop_tgt:`INCLUDE_DIRECTORIES` will be forwarded to ``SWIG`` compiler. + If set to ``FALSE`` or not defined, target property + :prop_tgt:`INCLUDE_DIRECTORIES` will be ignored. This behavior can be + overridden by specifying source property ``USE_TARGET_INCLUDE_DIRECTORIES``. + +``SWIG_GENERATED_INCLUDE_DIRECTORIES``, ``SWIG_GENERATED_COMPILE_DEFINITIONS`` and ``SWIG_GENERATED_COMPILE_OPTIONS`` + These properties will populate, respectively, properties + :prop_sf:`INCLUDE_DIRECTORIES`, :prop_sf:`COMPILE_DEFINITIONS` and + :prop_sf:`COMPILE_FLAGS` of all generated C/C++ files. + +``SWIG_DEPENDS`` + Add dependencies to all SWIG input files. + +The following target properties are output properties and can be used to get +information about support files generated by ``SWIG`` interface compilation. + +``SWIG_SUPPORT_FILES`` + This output property list of wrapper files generated during SWIG compilation. + + .. code-block:: cmake + + set (UseSWIG_TARGET_NAME_PREFERENCE STANDARD) + swig_add_library(mymod LANGUAGE python SOURCES mymod.i) + get_property(support_files TARGET mymod PROPERTY SWIG_SUPPORT_FILES) + + .. note:: + + Only most principal support files are listed. In case some advanced + features of ``SWIG`` are used (for example ``%template``), associated + support files may not be listed. Prefer to use the + ``SWIG_SUPPORT_FILES_DIRECTORY`` property to handle support files. + +``SWIG_SUPPORT_FILES_DIRECTORY`` + This output property specifies the directory where support files will be + generated. + +Some variables can be set to customize the behavior of ``swig_add_library`` +as well as ``SWIG``: + +``UseSWIG_MODULE_VERSION`` + Specify different behaviors for ``UseSWIG`` module. + + * Set to 1 or undefined: Legacy behavior is applied. + * Set to 2: A new strategy is applied regarding support files: the output + directory of support files is erased before ``SWIG`` interface compilation. + +``CMAKE_SWIG_FLAGS`` + Add flags to all swig calls. + +``CMAKE_SWIG_OUTDIR`` + Specify where to write the language specific files (swig ``-outdir`` option). + +``SWIG_OUTFILE_DIR`` + Specify an output directory name where the generated source file will be + placed. If not specified, ``CMAKE_SWIG_OUTDIR`` is used. + +``SWIG_MODULE__EXTRA_DEPS`` + Specify extra dependencies for the generated module for ````. + +``SWIG_SOURCE_FILE_EXTENSIONS`` + Specify a list of source file extensions to override the default + behavior of considering only ``.i`` files as sources for the ``SWIG`` + tool. For example: + + .. code-block:: cmake + + set(SWIG_SOURCE_FILE_EXTENSIONS ".i" ".swg") +#]=======================================================================] + +cmake_policy (VERSION 3.12) + +set(SWIG_CXX_EXTENSION "cxx") +set(SWIG_EXTRA_LIBRARIES "") + +set(SWIG_PYTHON_EXTRA_FILE_EXTENSIONS ".py") +set(SWIG_JAVA_EXTRA_FILE_EXTENSIONS ".java" "JNI.java") +set(SWIG_CSHARP_EXTRA_FILE_EXTENSIONS ".cs" "PINVOKE.cs") +set(SWIG_FORTRAN_EXTRA_FILE_EXTENSIONS ".f90") + +set(SWIG_MANAGE_SUPPORT_FILES_SCRIPT "${CMAKE_CURRENT_LIST_DIR}/UseSWIG/ManageSupportFiles.cmake") + +## +## PRIVATE functions +## +function (__SWIG_COMPUTE_TIMESTAMP name language infile workingdir __timestamp) + get_filename_component(filename "${infile}" NAME_WE) + set(${__timestamp} + "${workingdir}/${filename}${language}.stamp" PARENT_SCOPE) + # get_filename_component(filename "${infile}" ABSOLUTE) + # string(UUID uuid NAMESPACE 9735D882-D2F8-4E1D-88C9-A0A4F1F6ECA4 + # NAME ${name}-${language}-${filename} TYPE SHA1) + # set(${__timestamp} "${workingdir}/${uuid}.stamp" PARENT_SCOPE) +endfunction() + +# +# For given swig module initialize variables associated with it +# +macro(SWIG_MODULE_INITIALIZE name language) + string(TOUPPER "${language}" SWIG_MODULE_${name}_LANGUAGE) + string(TOLOWER "${language}" SWIG_MODULE_${name}_SWIG_LANGUAGE_FLAG) + + if (NOT DEFINED SWIG_MODULE_${name}_NOPROXY) + set (SWIG_MODULE_${name}_NOPROXY FALSE) + endif() + if ("-noproxy" IN_LIST CMAKE_SWIG_FLAGS) + set (SWIG_MODULE_${name}_NOPROXY TRUE) + endif () + + if (SWIG_MODULE_${name}_NOPROXY AND + NOT ("-noproxy" IN_LIST CMAKE_SWIG_FLAGS OR "-noproxy" IN_LIST SWIG_MODULE_${name}_EXTRA_FLAGS)) + list (APPEND SWIG_MODULE_${name}_EXTRA_FLAGS "-noproxy") + endif() + if(SWIG_MODULE_${name}_LANGUAGE STREQUAL "UNKNOWN") + message(FATAL_ERROR "SWIG Error: Language \"${language}\" not found") + elseif(SWIG_MODULE_${name}_LANGUAGE STREQUAL "PERL" AND + NOT "-shadow" IN_LIST SWIG_MODULE_${name}_EXTRA_FLAGS) + list(APPEND SWIG_MODULE_${name}_EXTRA_FLAGS "-shadow") + endif() +endmacro() + +# +# For a given language, input file, and output file, determine extra files that +# will be generated. This is internal swig macro. +# + +function(SWIG_GET_EXTRA_OUTPUT_FILES language outfiles generatedpath infile) + set(files) + get_source_file_property(module_basename + "${infile}" SWIG_MODULE_NAME) + if(NOT module_basename) + + # try to get module name from "%module foo" syntax + if ( EXISTS "${infile}" ) + file ( STRINGS "${infile}" module_basename REGEX "[ ]*%module[ ]*[a-zA-Z0-9_]+.*" ) + endif () + if ( module_basename ) + string ( REGEX REPLACE "[ ]*%module[ ]*([a-zA-Z0-9_]+).*" "\\1" module_basename "${module_basename}" ) + + else () + # try to get module name from "%module (options=...) foo" syntax + if ( EXISTS "${infile}" ) + file ( STRINGS "${infile}" module_basename REGEX "[ ]*%module[ ]*\\(.*\\)[ ]*[a-zA-Z0-9_]+.*" ) + endif () + if ( module_basename ) + string ( REGEX REPLACE "[ ]*%module[ ]*\\(.*\\)[ ]*([a-zA-Z0-9_]+).*" "\\1" module_basename "${module_basename}" ) + + else () + # fallback to file basename + get_filename_component(module_basename "${infile}" NAME_WE) + endif () + endif () + + endif() + foreach(it ${SWIG_${language}_EXTRA_FILE_EXTENSIONS}) + set(extra_file "${generatedpath}/${module_basename}${it}") + if (extra_file MATCHES "\\.cs$" AND CMAKE_CSharp_COMPILER_LOADED) + set_source_files_properties(${extra_file} PROPERTIES LANGUAGE "CSharp") + elseif (extra_file MATCHES "\\.f90$" AND CMAKE_Fortran_COMPILER_LOADED) + set_source_files_properties(${extra_file} PROPERTIES LANGUAGE "Fortran") + else() + # Treat extra outputs as plain files regardless of language. + set_source_files_properties(${extra_file} PROPERTIES LANGUAGE "") + endif() + list(APPEND files "${extra_file}") + endforeach() + + set (${outfiles} ${files} PARENT_SCOPE) +endfunction() + +# +# Take swig (*.i) file and add proper custom commands for it +# +function(SWIG_ADD_SOURCE_TO_MODULE name outfiles infile) + get_filename_component(swig_source_file_name_we "${infile}" NAME_WE) + get_source_file_property(swig_source_file_cplusplus "${infile}" CPLUSPLUS) + + # If CMAKE_SWIG_OUTDIR was specified then pass it to -outdir + if(CMAKE_SWIG_OUTDIR) + set(outdir ${CMAKE_SWIG_OUTDIR}) + else() + set(outdir ${CMAKE_CURRENT_BINARY_DIR}) + endif() + + if(SWIG_OUTFILE_DIR) + set(outfiledir ${SWIG_OUTFILE_DIR}) + else() + set(outfiledir ${outdir}) + endif() + + if(SWIG_WORKING_DIR) + set (workingdir "${SWIG_WORKING_DIR}") + else() + set(workingdir "${outdir}") + endif() + + if(SWIG_TARGET_NAME) + set(target_name ${SWIG_TARGET_NAME}) + else() + set(target_name ${name}) + endif() + + set (swig_source_file_flags ${CMAKE_SWIG_FLAGS}) + # handle various swig compile flags properties + get_source_file_property (include_directories "${infile}" INCLUDE_DIRECTORIES) + if (include_directories) + list (APPEND swig_source_file_flags "$<$:-I$-I>>") + endif() + set (property "$") + list (APPEND swig_source_file_flags "$<$:-I$,$-I>>") + set (property "$") + get_source_file_property(use_target_include_dirs "${infile}" USE_TARGET_INCLUDE_DIRECTORIES) + if (use_target_include_dirs) + list (APPEND swig_source_file_flags "$<$:-I$-I>>") + elseif(use_target_include_dirs STREQUAL "NOTFOUND") + # not defined at source level, rely on target level + list (APPEND swig_source_file_flags "$<$>,$>:-I$-I>>") + endif() + + set (property "$") + list (APPEND swig_source_file_flags "$<$:-D$,$-D>>") + get_source_file_property (compile_definitions "${infile}" COMPILE_DEFINITIONS) + if (compile_definitions) + list (APPEND swig_source_file_flags "$<$:-D$-D>>") + endif() + + list (APPEND swig_source_file_flags "$>") + get_source_file_property (compile_options "${infile}" COMPILE_OPTIONS) + if (compile_options) + list (APPEND swig_source_file_flags ${compile_options}) + endif() + + # legacy support + get_source_file_property (swig_flags "${infile}" SWIG_FLAGS) + if (swig_flags) + list (APPEND swig_source_file_flags ${swig_flags}) + endif() + + get_filename_component(swig_source_file_fullname "${infile}" ABSOLUTE) + + if (NOT SWIG_MODULE_${name}_NOPROXY) + SWIG_GET_EXTRA_OUTPUT_FILES(${SWIG_MODULE_${name}_LANGUAGE} + swig_extra_generated_files + "${outdir}" + "${swig_source_file_fullname}") + endif() + set(swig_generated_file_fullname + "${outfiledir}/${swig_source_file_name_we}") + # add the language into the name of the file (i.e. TCL_wrap) + # this allows for the same .i file to be wrapped into different languages + string(APPEND swig_generated_file_fullname + "${SWIG_MODULE_${name}_LANGUAGE}_wrap") + + if(swig_source_file_cplusplus) + string(APPEND swig_generated_file_fullname + ".${SWIG_CXX_EXTENSION}") + else() + string(APPEND swig_generated_file_fullname + ".c") + endif() + + get_directory_property (cmake_include_directories INCLUDE_DIRECTORIES) + list (REMOVE_DUPLICATES cmake_include_directories) + set (swig_include_dirs) + if (cmake_include_directories) + set (swig_include_dirs "$<$:-I$-I>>") + endif() + + set(swig_special_flags) + # default is c, so add c++ flag if it is c++ + if(swig_source_file_cplusplus) + list (APPEND swig_special_flags "-c++") + endif() + + set(module_name_policy "NEW") + if (module_name_policy STREQUAL "NEW") + get_source_file_property(module_name "${infile}" SWIG_MODULE_NAME) + if (module_name) + list (APPEND swig_special_flags "-module" "${module_name}") + endif() + endif() + + set (swig_extra_flags) + if(SWIG_MODULE_${name}_LANGUAGE STREQUAL "CSHARP") + if(NOT ("-dllimport" IN_LIST swig_source_file_flags OR "-dllimport" IN_LIST SWIG_MODULE_${name}_EXTRA_FLAGS)) + # This makes sure that the name used in the generated DllImport + # matches the library name created by CMake + list (APPEND SWIG_MODULE_${name}_EXTRA_FLAGS "-dllimport" "${name}") + endif() + endif() + list (APPEND swig_extra_flags ${SWIG_MODULE_${name}_EXTRA_FLAGS}) + + # dependencies + set (swig_dependencies ${SWIG_MODULE_${name}_EXTRA_DEPS} $) + get_source_file_property(file_depends "${infile}" DEPENDS) + if (file_depends) + list (APPEND swig_dependencies ${file_depends}) + endif() + + if (UseSWIG_MODULE_VERSION VERSION_GREATER 1) + # as part of custom command, start by removing old generated files + # to ensure obsolete files do not stay + set (swig_file_outdir "${workingdir}/${swig_source_file_name_we}.files") + set (swig_cleanup_command COMMAND "${CMAKE_COMMAND}" "-DSUPPORT_FILES_WORKING_DIRECTORY=${swig_file_outdir}" "-DSUPPORT_FILES_OUTPUT_DIRECTORY=${outdir}" -DACTION=CLEAN -P "${SWIG_MANAGE_SUPPORT_FILES_SCRIPT}") + set (swig_copy_command COMMAND "${CMAKE_COMMAND}" "-DSUPPORT_FILES_WORKING_DIRECTORY=${swig_file_outdir}" "-DSUPPORT_FILES_OUTPUT_DIRECTORY=${outdir}" -DACTION=COPY -P "${SWIG_MANAGE_SUPPORT_FILES_SCRIPT}") + else() + set (swig_file_outdir "${outdir}") + unset (swig_cleanup_command) + unset (swig_copy_command) + endif() + + # IMPLICIT_DEPENDS below can not handle situations where a dependent file is + # removed. We need an extra step with timestamp and custom target, see #16830 + # As this is needed only for Makefile generator do it conditionally + if(CMAKE_GENERATOR MATCHES "Make") + __swig_compute_timestamp(${name} ${SWIG_MODULE_${name}_LANGUAGE} + "${infile}" "${workingdir}" swig_generated_timestamp) + set(swig_custom_output "${swig_generated_timestamp}") + set(swig_custom_products + BYPRODUCTS "${swig_generated_file_fullname}" ${swig_extra_generated_files}) + set(swig_timestamp_command + COMMAND ${CMAKE_COMMAND} -E touch "${swig_generated_timestamp}") + else() + set(swig_custom_output + "${swig_generated_file_fullname}" ${swig_extra_generated_files}) + set(swig_custom_products) + set(swig_timestamp_command) + endif() + add_custom_command( + OUTPUT ${swig_custom_output} + ${swig_custom_products} + ${swig_cleanup_command} + # Let's create the ${outdir} at execution time, in case dir contains $(OutDir) + COMMAND "${CMAKE_COMMAND}" -E make_directory ${outdir} ${outfiledir} + ${swig_timestamp_command} + COMMAND "${CMAKE_COMMAND}" -E env "SWIG_LIB=${SWIG_DIR}" "${SWIG_EXECUTABLE}" + "-${SWIG_MODULE_${name}_SWIG_LANGUAGE_FLAG}" + "${swig_source_file_flags}" + -outdir "${swig_file_outdir}" + ${swig_special_flags} + ${swig_extra_flags} + "${swig_include_dirs}" + -o "${swig_generated_file_fullname}" + "${swig_source_file_fullname}" + ${swig_copy_command} + MAIN_DEPENDENCY "${swig_source_file_fullname}" + DEPENDS ${swig_dependencies} + IMPLICIT_DEPENDS CXX "${swig_source_file_fullname}" + COMMENT "Swig compile ${infile} for ${SWIG_MODULE_${name}_SWIG_LANGUAGE_FLAG}" + COMMAND_EXPAND_LISTS) + set_source_files_properties("${swig_generated_file_fullname}" ${swig_extra_generated_files} + PROPERTIES GENERATED 1) + + ## add all properties for generated file to various properties + get_property (include_directories SOURCE "${infile}" PROPERTY GENERATED_INCLUDE_DIRECTORIES) + set_property (SOURCE "${swig_generated_file_fullname}" PROPERTY INCLUDE_DIRECTORIES ${include_directories} $>) + + get_property (compile_definitions SOURCE "${infile}" PROPERTY GENERATED_COMPILE_DEFINITIONS) + set_property (SOURCE "${swig_generated_file_fullname}" PROPERTY COMPILE_DEFINITIONS $> ${compile_definitions}) + + get_property (compile_options SOURCE "${infile}" PROPERTY GENERATED_COMPILE_OPTIONS) + set_property (SOURCE "${swig_generated_file_fullname}" PROPERTY COMPILE_OPTIONS $> ${compile_options}) + + if (SWIG_MODULE_${name}_SWIG_LANGUAGE_FLAG MATCHES "php") + set_property (SOURCE "${swig_generated_file_fullname}" APPEND PROPERTY INCLUDE_DIRECTORIES "${outdir}") + endif() + + set(${outfiles} "${swig_generated_file_fullname}" ${swig_extra_generated_files} PARENT_SCOPE) + + # legacy support + set (swig_generated_file_fullname "${swig_generated_file_fullname}" PARENT_SCOPE) +endfunction() + +# +# Create Swig module +# +macro(SWIG_ADD_MODULE name language) + message(DEPRECATION "SWIG_ADD_MODULE is deprecated. Use SWIG_ADD_LIBRARY instead.") + swig_add_library(${name} + LANGUAGE ${language} + TYPE MODULE + SOURCES ${ARGN}) +endmacro() + + +function(SWIG_ADD_LIBRARY name) + set(options NO_PROXY) + set(oneValueArgs LANGUAGE + TYPE + OUTPUT_DIR + OUTFILE_DIR) + set(multiValueArgs SOURCES) + cmake_parse_arguments(_SAM "${options}" "${oneValueArgs}" "${multiValueArgs}" ${ARGN}) + + if (_SAM_UNPARSED_ARGUMENTS) + message(FATAL_ERROR "SWIG_ADD_LIBRARY: ${_SAM_UNPARSED_ARGUMENTS}: unexpected arguments") + endif() + + if(NOT DEFINED _SAM_LANGUAGE) + message(FATAL_ERROR "SWIG_ADD_LIBRARY: Missing LANGUAGE argument") + endif() + + if(NOT DEFINED _SAM_SOURCES) + message(FATAL_ERROR "SWIG_ADD_LIBRARY: Missing SOURCES argument") + endif() + + if(NOT DEFINED _SAM_TYPE) + set(_SAM_TYPE MODULE) + elseif(_SAM_TYPE STREQUAL "USE_BUILD_SHARED_LIBS") + unset(_SAM_TYPE) + endif() + + set(target_name_policy "NEW") + if (target_name_policy STREQUAL "NEW") + set (UseSWIG_TARGET_NAME_PREFERENCE STANDARD) + else() + if (NOT target_name_policy) + message(AUTHOR_WARNING "${_cmp0078_warning}\n") + endif() + if (NOT DEFINED UseSWIG_TARGET_NAME_PREFERENCE) + set (UseSWIG_TARGET_NAME_PREFERENCE LEGACY) + elseif (NOT UseSWIG_TARGET_NAME_PREFERENCE MATCHES "^(LEGACY|STANDARD)$") + message (FATAL_ERROR "UseSWIG_TARGET_NAME_PREFERENCE: ${UseSWIG_TARGET_NAME_PREFERENCE}: invalid value. 'LEGACY' or 'STANDARD' is expected.") + endif() + endif() + + if (NOT DEFINED UseSWIG_MODULE_VERSION) + set (UseSWIG_MODULE_VERSION 1) + elseif (NOT UseSWIG_MODULE_VERSION MATCHES "^(1|2)$") + message (FATAL_ERROR "UseSWIG_MODULE_VERSION: ${UseSWIG_MODULE_VERSION}: invalid value. 1 or 2 is expected.") + endif() + + set (SWIG_MODULE_${name}_NOPROXY ${_SAM_NO_PROXY}) + swig_module_initialize(${name} ${_SAM_LANGUAGE}) + + # compute real target name. + if (UseSWIG_TARGET_NAME_PREFERENCE STREQUAL "LEGACY" AND + SWIG_MODULE_${name}_LANGUAGE STREQUAL "PYTHON" AND NOT SWIG_MODULE_${name}_NOPROXY) + # swig will produce a module.py containing an 'import _modulename' statement, + # which implies having a corresponding _modulename.so (*NIX), _modulename.pyd (Win32), + # unless the -noproxy flag is used + set(target_name "_${name}") + else() + set(target_name "${name}") + endif() + + if (TARGET ${target_name}) + # a target with same name is already defined. + # call NOW add_library command to raise the most useful error message + add_library(${target_name}) + return() + endif() + + set (workingdir "${CMAKE_CURRENT_BINARY_DIR}${CMAKE_FILES_DIRECTORY}/${target_name}.dir") + # set special variable to pass extra information to command SWIG_ADD_SOURCE_TO_MODULE + # which cannot be changed due to legacy compatibility + set (SWIG_WORKING_DIR "${workingdir}") + set (SWIG_TARGET_NAME "${target_name}") + + set (outputdir "${_SAM_OUTPUT_DIR}") + if (NOT _SAM_OUTPUT_DIR) + if (CMAKE_SWIG_OUTDIR) + set (outputdir "${CMAKE_SWIG_OUTDIR}") + else() + if (UseSWIG_MODULE_VERSION VERSION_GREATER 1) + set (outputdir "${workingdir}/${_SAM_LANGUAGE}.files") + else() + set (outputdir "${CMAKE_CURRENT_BINARY_DIR}") + endif() + endif() + endif() + + set (outfiledir "${_SAM_OUTFILE_DIR}") + if(NOT _SAM_OUTFILE_DIR) + if (SWIG_OUTFILE_DIR) + set (outfiledir "${SWIG_OUTFILE_DIR}") + else() + if (_SAM_OUTPUT_DIR OR CMAKE_SWIG_OUTDIR) + set (outfiledir "${outputdir}") + else() + set (outfiledir "${workingdir}") + endif() + endif() + endif() + # set again, locally, predefined variables to ensure compatibility + # with command SWIG_ADD_SOURCE_TO_MODULE + set(CMAKE_SWIG_OUTDIR "${outputdir}") + set(SWIG_OUTFILE_DIR "${outfiledir}") + + # See if the user has specified source extensions for swig files? + if (NOT DEFINED SWIG_SOURCE_FILE_EXTENSIONS) + # Assume the default (*.i) file extension for Swig source files + set(SWIG_SOURCE_FILE_EXTENSIONS ".i") + endif() + + # Generate a regex out of file extensions. + string(REGEX REPLACE "([$^.*+?|()-])" "\\\\\\1" swig_source_ext_regex "${SWIG_SOURCE_FILE_EXTENSIONS}") + list (JOIN swig_source_ext_regex "|" swig_source_ext_regex) + string (PREPEND swig_source_ext_regex "(") + string (APPEND swig_source_ext_regex ")$") + + set(swig_dot_i_sources ${_SAM_SOURCES}) + list(FILTER swig_dot_i_sources INCLUDE REGEX ${swig_source_ext_regex}) + if (NOT swig_dot_i_sources) + message(FATAL_ERROR "SWIG_ADD_LIBRARY: no SWIG interface files specified") + endif() + set(swig_other_sources ${_SAM_SOURCES}) + list(REMOVE_ITEM swig_other_sources ${swig_dot_i_sources}) + + set(swig_generated_sources) + set(swig_generated_timestamps) + foreach(swig_it IN LISTS swig_dot_i_sources) + SWIG_ADD_SOURCE_TO_MODULE(${name} swig_generated_source "${swig_it}") + list (APPEND swig_generated_sources "${swig_generated_source}") + if(CMAKE_GENERATOR MATCHES "Make") + __swig_compute_timestamp(${name} ${SWIG_MODULE_${name}_LANGUAGE} "${swig_it}" + "${workingdir}" swig_timestamp) + list (APPEND swig_generated_timestamps "${swig_timestamp}") + endif() + endforeach() + set_property (DIRECTORY APPEND PROPERTY + ADDITIONAL_MAKE_CLEAN_FILES ${swig_generated_sources} ${swig_generated_timestamps}) + if (UseSWIG_MODULE_VERSION VERSION_GREATER 1) + set_property (DIRECTORY APPEND PROPERTY ADDITIONAL_MAKE_CLEAN_FILES "${outputdir}") + endif() + + add_library(${target_name} + ${_SAM_TYPE} + ${swig_generated_sources} + ${swig_other_sources}) + if(CMAKE_GENERATOR MATCHES "Make") + # see IMPLICIT_DEPENDS above + add_custom_target(${name}_swig_compilation DEPENDS ${swig_generated_timestamps}) + add_dependencies(${target_name} ${name}_swig_compilation) + endif() + if(_SAM_TYPE STREQUAL "MODULE") + set_target_properties(${target_name} PROPERTIES NO_SONAME ON) + endif() + string(TOLOWER "${_SAM_LANGUAGE}" swig_lowercase_language) + if (swig_lowercase_language STREQUAL "octave") + set_target_properties(${target_name} PROPERTIES PREFIX "") + set_target_properties(${target_name} PROPERTIES SUFFIX ".oct") + elseif (swig_lowercase_language STREQUAL "fortran") + # XXX + elseif (swig_lowercase_language STREQUAL "go") + set_target_properties(${target_name} PROPERTIES PREFIX "") + elseif (swig_lowercase_language STREQUAL "java") + # In java you want: + # System.loadLibrary("LIBRARY"); + # then JNI will look for a library whose name is platform dependent, namely + # MacOS : libLIBRARY.jnilib + # Windows: LIBRARY.dll + # Linux : libLIBRARY.so + if (APPLE) + set_target_properties (${target_name} PROPERTIES SUFFIX ".jnilib") + endif() + if ((WIN32 AND MINGW) OR CYGWIN OR CMAKE_SYSTEM_NAME STREQUAL MSYS) + set_target_properties(${target_name} PROPERTIES PREFIX "") + endif() + elseif (swig_lowercase_language STREQUAL "lua") + if(_SAM_TYPE STREQUAL "MODULE") + set_target_properties(${target_name} PROPERTIES PREFIX "") + endif() + elseif (swig_lowercase_language STREQUAL "python") + if (UseSWIG_TARGET_NAME_PREFERENCE STREQUAL "STANDARD" AND NOT SWIG_MODULE_${name}_NOPROXY) + # swig will produce a module.py containing an 'import _modulename' statement, + # which implies having a corresponding _modulename.so (*NIX), _modulename.pyd (Win32), + # unless the -noproxy flag is used + set_target_properties(${target_name} PROPERTIES PREFIX "_") + else() + set_target_properties(${target_name} PROPERTIES PREFIX "") + endif() + # Python extension modules on Windows must have the extension ".pyd" + # instead of ".dll" as of Python 2.5. Older python versions do support + # this suffix. + # http://docs.python.org/whatsnew/ports.html#SECTION0001510000000000000000 + # + # Windows: .dll is no longer supported as a filename extension for extension modules. + # .pyd is now the only filename extension that will be searched for. + # + if(WIN32 AND NOT CYGWIN) + set_target_properties(${target_name} PROPERTIES SUFFIX ".pyd") + endif() + elseif (swig_lowercase_language STREQUAL "r") + set_target_properties(${target_name} PROPERTIES PREFIX "") + elseif (swig_lowercase_language STREQUAL "ruby") + # In ruby you want: + # require 'LIBRARY' + # then ruby will look for a library whose name is platform dependent, namely + # MacOS : LIBRARY.bundle + # Windows: LIBRARY.dll + # Linux : LIBRARY.so + set_target_properties (${target_name} PROPERTIES PREFIX "") + if (APPLE) + set_target_properties (${target_name} PROPERTIES SUFFIX ".bundle") + endif () + elseif (swig_lowercase_language STREQUAL "perl") + # assume empty prefix because we expect the module to be dynamically loaded + set_target_properties (${target_name} PROPERTIES PREFIX "") + if (APPLE) + set_target_properties (${target_name} PROPERTIES SUFFIX ".dylib") + endif () + else() + # assume empty prefix because we expect the module to be dynamically loaded + set_target_properties (${target_name} PROPERTIES PREFIX "") + endif () + + # target property SWIG_SUPPORT_FILES_DIRECTORY specify output directory of support files + set_property (TARGET ${target_name} PROPERTY SWIG_SUPPORT_FILES_DIRECTORY "${outputdir}") + # target property SWIG_SUPPORT_FILES lists principal proxy support files + if (NOT SWIG_MODULE_${name}_NOPROXY) + string(TOUPPER "${_SAM_LANGUAGE}" swig_uppercase_language) + set(swig_all_support_files) + foreach (swig_it IN LISTS SWIG_${swig_uppercase_language}_EXTRA_FILE_EXTENSIONS) + set (swig_support_files ${swig_generated_sources}) + list (FILTER swig_support_files INCLUDE REGEX ".*${swig_it}$") + list(APPEND swig_all_support_files ${swig_support_files}) + endforeach() + if (swig_all_support_files) + list(REMOVE_DUPLICATES swig_all_support_files) + endif() + set_property (TARGET ${target_name} PROPERTY SWIG_SUPPORT_FILES ${swig_all_support_files}) + endif() + + # to ensure legacy behavior, export some variables + set (SWIG_MODULE_${name}_LANGUAGE "${SWIG_MODULE_${name}_LANGUAGE}" PARENT_SCOPE) + set (SWIG_MODULE_${name}_SWIG_LANGUAGE_FLAG "${SWIG_MODULE_${name}_SWIG_LANGUAGE_FLAG}" PARENT_SCOPE) + set (SWIG_MODULE_${name}_REAL_NAME "${target_name}" PARENT_SCOPE) + set (SWIG_MODULE_${name}_NOPROXY "${SWIG_MODULE_${name}_NOPROXY}" PARENT_SCOPE) + set (SWIG_MODULE_${name}_EXTRA_FLAGS "${SWIG_MODULE_${name}_EXTRA_FLAGS}" PARENT_SCOPE) + # the last one is a bit crazy but it is documented, so... + # NOTA: works as expected if only ONE input file is specified + set (swig_generated_file_fullname "${swig_generated_file_fullname}" PARENT_SCOPE) +endfunction() + +# +# Like TARGET_LINK_LIBRARIES but for swig modules +# +function(SWIG_LINK_LIBRARIES name) + if (UseSWIG_TARGET_NAME_PREFERENCE STREQUAL "STANDARD") + message(DEPRECATION "SWIG_LINK_LIBRARIES is deprecated. Use TARGET_LINK_LIBRARIES instead.") + target_link_libraries(${name} ${ARGN}) + else() + if(SWIG_MODULE_${name}_REAL_NAME) + target_link_libraries(${SWIG_MODULE_${name}_REAL_NAME} ${ARGN}) + else() + message(SEND_ERROR "Cannot find Swig library \"${name}\".") + endif() + endif() +endfunction() diff --git a/cmake/UseSWIG.cmake b/cmake/UseSWIGOld.cmake similarity index 100% rename from cmake/UseSWIG.cmake rename to cmake/UseSWIGOld.cmake diff --git a/src/teuchos/src/CMakeLists.txt b/src/teuchos/src/CMakeLists.txt index 4b7e77f4..b1305c47 100644 --- a/src/teuchos/src/CMakeLists.txt +++ b/src/teuchos/src/CMakeLists.txt @@ -11,13 +11,9 @@ IF (ForTrilinos_ENABLE_DeveloperMode) SET(CMAKE_SWIG_OUTDIR "${CMAKE_CURRENT_SOURCE_DIR}/swig") ENDIF() - LIST(APPEND CMAKE_SWIG_FLAGS -I${CMAKE_CURRENT_SOURCE_DIR}/../../utils/src/) MAKE_SWIG_FORTRAN(MODULE forteuchos SOURCE forteuchos.i - DEPLIBS ${Trilinos_LIBRARIES} - EXTRASRC ${EXTRA_SOURCE} ) - ELSE() # Use pre-generated files SET(GEN_SOURCE @@ -26,7 +22,7 @@ ELSE() TRIBITS_ADD_LIBRARY( forteuchos - SOURCES ${GEN_SOURCE} ${EXTRA_SOURCE}) + SOURCES ${GEN_SOURCE}) ENDIF() INSTALL(FILES ${CMAKE_CURRENT_BINARY_DIR}/forteuchos.mod DESTINATION include) From 10bc19d625e7be6caeb1b7cc35388f1bfdf9840f Mon Sep 17 00:00:00 2001 From: Seth R Johnson Date: Fri, 1 Feb 2019 12:51:48 -0500 Subject: [PATCH 04/40] Converts code to use native Fortran logic type --- src/teuchos/src/Teuchos_Array.i | 3 +- src/teuchos/src/forteuchos.i | 3 - src/teuchos/src/swig/forteuchos.f90 | 50 +- .../src/swig/forteuchosFORTRAN_wrap.cxx | 20 +- src/teuchos/test/test_teuchos_plist.f90 | 4 +- src/tpetra/src/fortpetra.i | 5 - src/tpetra/src/swig/fortpetra.f90 | 868 +++++++++--------- src/tpetra/src/swig/fortpetraFORTRAN_wrap.cxx | 460 +++++----- src/tpetra/test/test_tpetra_crsgraph.f90 | 28 +- src/tpetra/test/test_tpetra_crsmatrix.f90 | 16 +- src/tpetra/test/test_tpetra_multivector.f90 | 2 +- src/tpetra/tutorials/MapsAndVectors.f90 | 2 +- src/tpetra/tutorials/PowerMethod.f90 | 4 +- src/utils/src/fortest.f90 | 30 +- 14 files changed, 750 insertions(+), 745 deletions(-) diff --git a/src/teuchos/src/Teuchos_Array.i b/src/teuchos/src/Teuchos_Array.i index 92e1b8df..e56ea751 100644 --- a/src/teuchos/src/Teuchos_Array.i +++ b/src/teuchos/src/Teuchos_Array.i @@ -26,10 +26,9 @@ class Array // Add native wrapping typemaps to convert to/from Teuchos array %std_native_container(Teuchos::Array) -%apply const Teuchos::Array& NATIVE { const Teuchos::Array& } - // Instantiate the typemaps without generating wrappers %template() Teuchos::Array; + %enddef TEUCHOS_ARRAY(int); diff --git a/src/teuchos/src/forteuchos.i b/src/teuchos/src/forteuchos.i index d75374c2..117f2195 100644 --- a/src/teuchos/src/forteuchos.i +++ b/src/teuchos/src/forteuchos.i @@ -21,9 +21,6 @@ typedef int Teuchos_Ordinal; %fortran_view(double) %fortran_view(size_t) -// FIXME: Restore previous bool behaviour -FORT_FUND_TYPEMAP(bool, logical(C_BOOL)) - // Convert all std::string references/values to and from Fortran strings %include diff --git a/src/teuchos/src/swig/forteuchos.f90 b/src/teuchos/src/swig/forteuchos.f90 index 8e5a3b43..6f6a94f0 100644 --- a/src/teuchos/src/swig/forteuchos.f90 +++ b/src/teuchos/src/swig/forteuchos.f90 @@ -244,7 +244,7 @@ function swigc_ParameterList_is_parameter(farg1, farg2) & import :: swigarraywrapper type(SwigClassWrapper) :: farg1 type(SwigArrayWrapper) :: farg2 -logical(C_BOOL) :: fresult +integer(C_INT) :: fresult end function function swigc_ParameterList_sublist(farg1, farg2) & @@ -295,7 +295,7 @@ subroutine swigc_ParameterList_set__SWIG_4(farg1, farg2, farg3) & import :: swigarraywrapper type(SwigClassWrapper) :: farg1 type(SwigArrayWrapper) :: farg2 -logical(C_BOOL), intent(in) :: farg3 +integer(C_INT), intent(in) :: farg3 end subroutine subroutine swigc_ParameterList_set__SWIG_5(farg1, farg2, farg3) & @@ -389,7 +389,7 @@ function swigc_ParameterList_get_logical(farg1, farg2) & import :: swigarraywrapper type(SwigClassWrapper) :: farg1 type(SwigArrayWrapper) :: farg2 -logical(C_BOOL) :: fresult +integer(C_INT) :: fresult end function function swigc_ParameterList_get_string(farg1, farg2) & @@ -639,23 +639,36 @@ subroutine swigf_ParameterList_remove(self, name) call swigc_ParameterList_remove(farg1, farg2) end subroutine + +function SWIG_int_to_logical(inp) & + result(out) + use, intrinsic :: ISO_C_BINDING + integer(kind=C_INT), intent(IN) :: inp + logical :: out + if (inp /= 0) then + out = .true. + else + out = .false. + end if +end function + function swigf_ParameterList_is_parameter(self, name) & result(swig_result) use, intrinsic :: ISO_C_BINDING -logical(C_BOOL) :: swig_result +logical :: swig_result class(ParameterList), intent(in) :: self character(kind=C_CHAR, len=*), target :: name character(kind=C_CHAR), dimension(:), allocatable, target :: farg2_chars -logical(C_BOOL) :: fresult +integer(C_INT) :: fresult type(SwigClassWrapper) :: farg1 type(SwigArrayWrapper) :: farg2 farg1 = self%swigdata call SWIG_string_to_chararray(name, farg2_chars, farg2) fresult = swigc_ParameterList_is_parameter(farg1, farg2) -swig_result = fresult +swig_result = SWIG_int_to_logical(fresult) end function function swigf_ParameterList_sublist(self, name) & @@ -731,21 +744,34 @@ subroutine swigf_ParameterList_set__SWIG_3(self, name, value) call swigc_ParameterList_set__SWIG_3(farg1, farg2, farg3) end subroutine + +function SWIG_logical_to_int(inp) & + result(out) + use, intrinsic :: ISO_C_BINDING + logical, intent(IN) :: inp + integer(kind=C_INT) :: out + if (inp .eqv. .true.) then + out = 1 + else + out = 0 + end if +end function + subroutine swigf_ParameterList_set__SWIG_4(self, name, value) use, intrinsic :: ISO_C_BINDING class(ParameterList), intent(inout) :: self character(kind=C_CHAR, len=*), target :: name character(kind=C_CHAR), dimension(:), allocatable, target :: farg2_chars -logical(C_BOOL), intent(in) :: value +logical, intent(in) :: value type(SwigClassWrapper) :: farg1 type(SwigArrayWrapper) :: farg2 -logical(C_BOOL) :: farg3 +integer(C_INT) :: farg3 farg1 = self%swigdata call SWIG_string_to_chararray(name, farg2_chars, farg2) -farg3 = value +farg3 = SWIG_logical_to_int(value) call swigc_ParameterList_set__SWIG_4(farg1, farg2, farg3) end subroutine @@ -909,20 +935,20 @@ function swigf_ParameterList_get_longlong(self, name) & function swigf_ParameterList_get_logical(self, name) & result(swig_result) use, intrinsic :: ISO_C_BINDING -logical(C_BOOL) :: swig_result +logical :: swig_result class(ParameterList), intent(inout) :: self character(kind=C_CHAR, len=*), target :: name character(kind=C_CHAR), dimension(:), allocatable, target :: farg2_chars -logical(C_BOOL) :: fresult +integer(C_INT) :: fresult type(SwigClassWrapper) :: farg1 type(SwigArrayWrapper) :: farg2 farg1 = self%swigdata call SWIG_string_to_chararray(name, farg2_chars, farg2) fresult = swigc_ParameterList_get_logical(farg1, farg2) -swig_result = fresult +swig_result = SWIG_int_to_logical(fresult) end function diff --git a/src/teuchos/src/swig/forteuchosFORTRAN_wrap.cxx b/src/teuchos/src/swig/forteuchosFORTRAN_wrap.cxx index 0f545afe..922b71d0 100644 --- a/src/teuchos/src/swig/forteuchosFORTRAN_wrap.cxx +++ b/src/teuchos/src/swig/forteuchosFORTRAN_wrap.cxx @@ -1017,8 +1017,8 @@ SWIGEXPORT void _wrap_ParameterList_remove(SwigClassWrapper const *farg1, SwigAr } -SWIGEXPORT bool _wrap_ParameterList_is_parameter(SwigClassWrapper const *farg1, SwigArrayWrapper *farg2) { - bool fresult ; +SWIGEXPORT int _wrap_ParameterList_is_parameter(SwigClassWrapper const *farg1, SwigArrayWrapper *farg2) { + int fresult ; Teuchos::ParameterList *arg1 = (Teuchos::ParameterList *) 0 ; std::string *arg2 = 0 ; Teuchos::RCP< Teuchos::ParameterList const > *smartarg1 ; @@ -1052,7 +1052,7 @@ SWIGEXPORT bool _wrap_ParameterList_is_parameter(SwigClassWrapper const *farg1, SWIG_exception_impl("Teuchos::ParameterList::isParameter(std::string const &) const", SWIG_UnknownError, "An unknown exception occurred", return 0); } } - fresult = static_cast< bool >(result); + fresult = (result ? 1 : 0); return fresult; } @@ -1223,20 +1223,20 @@ SWIGEXPORT void _wrap_ParameterList_set__SWIG_3(SwigClassWrapper const *farg1, S } -SWIGEXPORT void _wrap_ParameterList_set__SWIG_4(SwigClassWrapper const *farg1, SwigArrayWrapper *farg2, bool const *farg3) { +SWIGEXPORT void _wrap_ParameterList_set__SWIG_4(SwigClassWrapper const *farg1, SwigArrayWrapper *farg2, int const *farg3) { Teuchos::ParameterList *arg1 = (Teuchos::ParameterList *) 0 ; std::string *arg2 = 0 ; bool *arg3 = 0 ; Teuchos::RCP< Teuchos::ParameterList > *smartarg1 ; std::string tempstr2 ; - bool temp3 ; + bool tempbool3 ; smartarg1 = static_cast< Teuchos::RCP< Teuchos::ParameterList >* >(farg1->cptr); arg1 = smartarg1 ? const_cast< Teuchos::ParameterList* >(smartarg1->get()) : NULL; tempstr2 = std::string(static_cast(farg2->data), farg2->size); arg2 = &tempstr2; - temp3 = static_cast< bool >(*farg3); - arg3 = &temp3; + tempbool3 = (*farg3 ? true : false); + arg3 = &tempbool3; { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Teuchos::ParameterList::set< bool >(std::string const &,bool const &)");; @@ -1596,8 +1596,8 @@ SWIGEXPORT long long _wrap_ParameterList_get_longlong(SwigClassWrapper const *fa } -SWIGEXPORT bool _wrap_ParameterList_get_logical(SwigClassWrapper const *farg1, SwigArrayWrapper *farg2) { - bool fresult ; +SWIGEXPORT int _wrap_ParameterList_get_logical(SwigClassWrapper const *farg1, SwigArrayWrapper *farg2) { + int fresult ; Teuchos::ParameterList *arg1 = (Teuchos::ParameterList *) 0 ; std::string *arg2 = 0 ; Teuchos::RCP< Teuchos::ParameterList > *smartarg1 ; @@ -1631,7 +1631,7 @@ SWIGEXPORT bool _wrap_ParameterList_get_logical(SwigClassWrapper const *farg1, S SWIG_exception_impl("Teuchos::ParameterList::get< bool >(std::string const &)", SWIG_UnknownError, "An unknown exception occurred", return 0); } } - fresult = *result; + fresult = (result ? 1 : 0); return fresult; } diff --git a/src/teuchos/test/test_teuchos_plist.f90 b/src/teuchos/test/test_teuchos_plist.f90 index 623fb54a..03fe8e18 100644 --- a/src/teuchos/test/test_teuchos_plist.f90 +++ b/src/teuchos/test/test_teuchos_plist.f90 @@ -31,7 +31,7 @@ program test_TeuchosPList real(C_DOUBLE), allocatable :: darr(:) integer(C_INT) :: ival real(C_DOUBLE) :: dval - logical(C_BOOL) :: bval, true=.true. ! FIXME: can we get rid of this true somethow? + logical :: bval character(kind=C_CHAR, len=:), allocatable :: sval OUT0('Starting TeuchosPList_Basic!') @@ -53,7 +53,7 @@ program test_TeuchosPList TEST_FLOATING_EQUALITY(dval, 1.25_C_DOUBLE, epsilon(1.0_C_DOUBLE)) bval = .false. - call plist%set('mybool', true) + call plist%set('mybool', .true.) bval = plist%get_logical('mybool') TEST_ASSERT(bval) diff --git a/src/tpetra/src/fortpetra.i b/src/tpetra/src/fortpetra.i index a639a0ed..12535573 100644 --- a/src/tpetra/src/fortpetra.i +++ b/src/tpetra/src/fortpetra.i @@ -31,9 +31,6 @@ typedef Kokkos::Compat::KokkosSerialWrapperNode NO; typedef char Packet; %} -// FIXME: Restore previous bool behaviour -FORT_FUND_TYPEMAP(bool, logical(C_BOOL)) - // NOTE: with the latest SWIG, these will *not* show up in downstream // %imported modules even if %insert is replaced with %fragment. %insert("fuse") { @@ -49,7 +46,6 @@ FORT_FUND_TYPEMAP(bool, logical(C_BOOL)) global_ordinal_type => c_long_long, & global_size_type => c_long, & size_type => c_size_t, & - bool_type => c_bool, & int_type => c_int, & mag_type => c_double, & norm_type => c_double @@ -60,7 +56,6 @@ public :: local_ordinal_type public :: global_ordinal_type public :: global_size_type public :: size_type -public :: bool_type public :: int_type public :: mag_type public :: norm_type diff --git a/src/tpetra/src/swig/fortpetra.f90 b/src/tpetra/src/swig/fortpetra.f90 index ca464cd0..975bb2c7 100644 --- a/src/tpetra/src/swig/fortpetra.f90 +++ b/src/tpetra/src/swig/fortpetra.f90 @@ -26,7 +26,6 @@ module fortpetra global_ordinal_type => c_long_long, & global_size_type => c_long, & size_type => c_size_t, & - bool_type => c_bool, & int_type => c_int, & mag_type => c_double, & norm_type => c_double @@ -41,7 +40,6 @@ module fortpetra public :: global_ordinal_type public :: global_size_type public :: size_type -public :: bool_type public :: int_type public :: mag_type public :: norm_type @@ -738,7 +736,7 @@ function swigc_TpetraMap_isOneToOne(farg1) & use, intrinsic :: ISO_C_BINDING import :: swigclasswrapper type(SwigClassWrapper) :: farg1 -logical(C_BOOL) :: fresult +integer(C_INT) :: fresult end function function swigc_TpetraMap_getGlobalNumElements(farg1) & @@ -840,7 +838,7 @@ function swigc_TpetraMap_isNodeLocalElement(farg1, farg2) & import :: swigclasswrapper type(SwigClassWrapper) :: farg1 integer(C_INT), intent(in) :: farg2 -logical(C_BOOL) :: fresult +integer(C_INT) :: fresult end function function swigc_TpetraMap_isNodeGlobalElement(farg1, farg2) & @@ -850,7 +848,7 @@ function swigc_TpetraMap_isNodeGlobalElement(farg1, farg2) & import :: swigclasswrapper type(SwigClassWrapper) :: farg1 integer(C_LONG_LONG), intent(in) :: farg2 -logical(C_BOOL) :: fresult +integer(C_INT) :: fresult end function function swigc_TpetraMap_isUniform(farg1) & @@ -859,7 +857,7 @@ function swigc_TpetraMap_isUniform(farg1) & use, intrinsic :: ISO_C_BINDING import :: swigclasswrapper type(SwigClassWrapper) :: farg1 -logical(C_BOOL) :: fresult +integer(C_INT) :: fresult end function function swigc_TpetraMap_isContiguous(farg1) & @@ -868,7 +866,7 @@ function swigc_TpetraMap_isContiguous(farg1) & use, intrinsic :: ISO_C_BINDING import :: swigclasswrapper type(SwigClassWrapper) :: farg1 -logical(C_BOOL) :: fresult +integer(C_INT) :: fresult end function function swigc_TpetraMap_isDistributed(farg1) & @@ -877,7 +875,7 @@ function swigc_TpetraMap_isDistributed(farg1) & use, intrinsic :: ISO_C_BINDING import :: swigclasswrapper type(SwigClassWrapper) :: farg1 -logical(C_BOOL) :: fresult +integer(C_INT) :: fresult end function function swigc_TpetraMap_isCompatible(farg1, farg2) & @@ -887,7 +885,7 @@ function swigc_TpetraMap_isCompatible(farg1, farg2) & import :: swigclasswrapper type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 -logical(C_BOOL) :: fresult +integer(C_INT) :: fresult end function function swigc_TpetraMap_isSameAs(farg1, farg2) & @@ -897,7 +895,7 @@ function swigc_TpetraMap_isSameAs(farg1, farg2) & import :: swigclasswrapper type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 -logical(C_BOOL) :: fresult +integer(C_INT) :: fresult end function function swigc_TpetraMap_locallySameAs(farg1, farg2) & @@ -907,7 +905,7 @@ function swigc_TpetraMap_locallySameAs(farg1, farg2) & import :: swigclasswrapper type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 -logical(C_BOOL) :: fresult +integer(C_INT) :: fresult end function function swigc_TpetraMap_isLocallyFitted(farg1, farg2) & @@ -917,7 +915,7 @@ function swigc_TpetraMap_isLocallyFitted(farg1, farg2) & import :: swigclasswrapper type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 -logical(C_BOOL) :: fresult +integer(C_INT) :: fresult end function function swigc_TpetraMap_getComm(farg1) & @@ -1158,7 +1156,7 @@ function swigc_TpetraExport_isLocallyComplete(farg1) & use, intrinsic :: ISO_C_BINDING import :: swigclasswrapper type(SwigClassWrapper) :: farg1 -logical(C_BOOL) :: fresult +integer(C_INT) :: fresult end function subroutine swigc_assignment_TpetraExport(self, other) & @@ -1282,7 +1280,7 @@ function swigc_TpetraImport_isLocallyComplete(farg1) & use, intrinsic :: ISO_C_BINDING import :: swigclasswrapper type(SwigClassWrapper) :: farg1 -logical(C_BOOL) :: fresult +integer(C_INT) :: fresult end function function swigc_TpetraImport_setUnion__SWIG_0(farg1, farg2) & @@ -1336,7 +1334,7 @@ function swigc_new_TpetraMultiVector__SWIG_1(farg1, farg2, farg3) & import :: swigclasswrapper type(SwigClassWrapper) :: farg1 integer(C_SIZE_T), intent(in) :: farg2 -logical(C_BOOL), intent(in) :: farg3 +integer(C_INT), intent(in) :: farg3 type(SwigClassWrapper) :: fresult end function @@ -1423,7 +1421,7 @@ subroutine swigc_TpetraMultiVector_sumIntoGlobalValue__SWIG_0(farg1, farg2, farg integer(C_LONG_LONG), intent(in) :: farg2 integer(C_SIZE_T), intent(in) :: farg3 real(C_DOUBLE), intent(in) :: farg4 -logical(C_BOOL), intent(in) :: farg5 +integer(C_INT), intent(in) :: farg5 end subroutine subroutine swigc_TpetraMultiVector_sumIntoGlobalValue__SWIG_1(farg1, farg2, farg3, farg4) & @@ -1454,7 +1452,7 @@ subroutine swigc_TpetraMultiVector_sumIntoLocalValue__SWIG_0(farg1, farg2, farg3 integer(C_INT), intent(in) :: farg2 integer(C_SIZE_T), intent(in) :: farg3 real(C_DOUBLE), intent(in) :: farg4 -logical(C_BOOL), intent(in) :: farg5 +integer(C_INT), intent(in) :: farg5 end subroutine subroutine swigc_TpetraMultiVector_sumIntoLocalValue__SWIG_1(farg1, farg2, farg3, farg4) & @@ -1548,7 +1546,7 @@ function swigc_TpetraMultiVector_need_sync_host(farg1) & use, intrinsic :: ISO_C_BINDING import :: swigclasswrapper type(SwigClassWrapper) :: farg1 -logical(C_BOOL) :: fresult +integer(C_INT) :: fresult end function function swigc_TpetraMultiVector_need_sync_device(farg1) & @@ -1557,7 +1555,7 @@ function swigc_TpetraMultiVector_need_sync_device(farg1) & use, intrinsic :: ISO_C_BINDING import :: swigclasswrapper type(SwigClassWrapper) :: farg1 -logical(C_BOOL) :: fresult +integer(C_INT) :: fresult end function subroutine swigc_TpetraMultiVector_modify_device(farg1) & @@ -1684,7 +1682,7 @@ function swigc_TpetraMultiVector_isConstantStride(farg1) & use, intrinsic :: ISO_C_BINDING import :: swigclasswrapper type(SwigClassWrapper) :: farg1 -logical(C_BOOL) :: fresult +integer(C_INT) :: fresult end function function swigc_TpetraMultiVector_description(farg1) & @@ -1729,7 +1727,7 @@ function swigc_TpetraMultiVector_isSameSize(farg1, farg2) & import :: swigclasswrapper type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 -logical(C_BOOL) :: fresult +integer(C_INT) :: fresult end function function swigc_new_TpetraMultiVector__SWIG_8(farg1, farg2, farg3, farg4) & @@ -2205,7 +2203,7 @@ function swigc_TpetraCrsGraph_isIdenticalTo(farg1, farg2) & import :: swigclasswrapper type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 -logical(C_BOOL) :: fresult +integer(C_INT) :: fresult end function subroutine swigc_TpetraCrsGraph_setParameterList(farg1, farg2) & @@ -2567,7 +2565,7 @@ function swigc_TpetraCrsGraph_hasColMap(farg1) & use, intrinsic :: ISO_C_BINDING import :: swigclasswrapper type(SwigClassWrapper) :: farg1 -logical(C_BOOL) :: fresult +integer(C_INT) :: fresult end function function swigc_TpetraCrsGraph_isLowerTriangularImpl(farg1) & @@ -2576,7 +2574,7 @@ function swigc_TpetraCrsGraph_isLowerTriangularImpl(farg1) & use, intrinsic :: ISO_C_BINDING import :: swigclasswrapper type(SwigClassWrapper) :: farg1 -logical(C_BOOL) :: fresult +integer(C_INT) :: fresult end function function swigc_TpetraCrsGraph_isLowerTriangular(farg1) & @@ -2585,7 +2583,7 @@ function swigc_TpetraCrsGraph_isLowerTriangular(farg1) & use, intrinsic :: ISO_C_BINDING import :: swigclasswrapper type(SwigClassWrapper) :: farg1 -logical(C_BOOL) :: fresult +integer(C_INT) :: fresult end function function swigc_TpetraCrsGraph_isUpperTriangularImpl(farg1) & @@ -2594,7 +2592,7 @@ function swigc_TpetraCrsGraph_isUpperTriangularImpl(farg1) & use, intrinsic :: ISO_C_BINDING import :: swigclasswrapper type(SwigClassWrapper) :: farg1 -logical(C_BOOL) :: fresult +integer(C_INT) :: fresult end function function swigc_TpetraCrsGraph_isUpperTriangular(farg1) & @@ -2603,7 +2601,7 @@ function swigc_TpetraCrsGraph_isUpperTriangular(farg1) & use, intrinsic :: ISO_C_BINDING import :: swigclasswrapper type(SwigClassWrapper) :: farg1 -logical(C_BOOL) :: fresult +integer(C_INT) :: fresult end function function swigc_TpetraCrsGraph_isLocallyIndexed(farg1) & @@ -2612,7 +2610,7 @@ function swigc_TpetraCrsGraph_isLocallyIndexed(farg1) & use, intrinsic :: ISO_C_BINDING import :: swigclasswrapper type(SwigClassWrapper) :: farg1 -logical(C_BOOL) :: fresult +integer(C_INT) :: fresult end function function swigc_TpetraCrsGraph_isGloballyIndexed(farg1) & @@ -2621,7 +2619,7 @@ function swigc_TpetraCrsGraph_isGloballyIndexed(farg1) & use, intrinsic :: ISO_C_BINDING import :: swigclasswrapper type(SwigClassWrapper) :: farg1 -logical(C_BOOL) :: fresult +integer(C_INT) :: fresult end function function swigc_TpetraCrsGraph_isFillComplete(farg1) & @@ -2630,7 +2628,7 @@ function swigc_TpetraCrsGraph_isFillComplete(farg1) & use, intrinsic :: ISO_C_BINDING import :: swigclasswrapper type(SwigClassWrapper) :: farg1 -logical(C_BOOL) :: fresult +integer(C_INT) :: fresult end function function swigc_TpetraCrsGraph_isFillActive(farg1) & @@ -2639,7 +2637,7 @@ function swigc_TpetraCrsGraph_isFillActive(farg1) & use, intrinsic :: ISO_C_BINDING import :: swigclasswrapper type(SwigClassWrapper) :: farg1 -logical(C_BOOL) :: fresult +integer(C_INT) :: fresult end function function swigc_TpetraCrsGraph_isSorted(farg1) & @@ -2648,7 +2646,7 @@ function swigc_TpetraCrsGraph_isSorted(farg1) & use, intrinsic :: ISO_C_BINDING import :: swigclasswrapper type(SwigClassWrapper) :: farg1 -logical(C_BOOL) :: fresult +integer(C_INT) :: fresult end function function swigc_TpetraCrsGraph_isStorageOptimized(farg1) & @@ -2657,7 +2655,7 @@ function swigc_TpetraCrsGraph_isStorageOptimized(farg1) & use, intrinsic :: ISO_C_BINDING import :: swigclasswrapper type(SwigClassWrapper) :: farg1 -logical(C_BOOL) :: fresult +integer(C_INT) :: fresult end function function swigc_TpetraCrsGraph_getProfileType(farg1) & @@ -2675,7 +2673,7 @@ function swigc_TpetraCrsGraph_supportsRowViews(farg1) & use, intrinsic :: ISO_C_BINDING import :: swigclasswrapper type(SwigClassWrapper) :: farg1 -logical(C_BOOL) :: fresult +integer(C_INT) :: fresult end function function swigc_TpetraCrsGraph_description(farg1) & @@ -2703,7 +2701,7 @@ subroutine swigc_TpetraCrsGraph_reindexColumns__SWIG_0(farg1, farg2, farg3, farg type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 type(SwigClassWrapper) :: farg3 -logical(C_BOOL), intent(in) :: farg4 +integer(C_INT), intent(in) :: farg4 end subroutine subroutine swigc_TpetraCrsGraph_reindexColumns__SWIG_1(farg1, farg2, farg3) & @@ -2837,7 +2835,7 @@ function swigc_TpetraCrsGraph_haveGlobalConstants(farg1) & use, intrinsic :: ISO_C_BINDING import :: swigclasswrapper type(SwigClassWrapper) :: farg1 -logical(C_BOOL) :: fresult +integer(C_INT) :: fresult end function subroutine swigc_TpetraCrsGraph_computeGlobalConstants(farg1, farg2) & @@ -2845,7 +2843,7 @@ subroutine swigc_TpetraCrsGraph_computeGlobalConstants(farg1, farg2) & use, intrinsic :: ISO_C_BINDING import :: swigclasswrapper type(SwigClassWrapper) :: farg1 -logical(C_BOOL), intent(in) :: farg2 +integer(C_INT), intent(in) :: farg2 end subroutine function swigc_new_TpetraCrsGraph__SWIG_6(farg1, farg2, farg3, farg4) & @@ -3333,7 +3331,7 @@ subroutine swigc_TpetraCrsMatrix_reindexColumns__SWIG_0(farg1, farg2, farg3, far type(SwigClassWrapper) :: farg2 type(SwigClassWrapper) :: farg3 type(SwigClassWrapper) :: farg4 -logical(C_BOOL), intent(in) :: farg5 +integer(C_INT), intent(in) :: farg5 end subroutine subroutine swigc_TpetraCrsMatrix_reindexColumns__SWIG_1(farg1, farg2, farg3, farg4) & @@ -3542,7 +3540,7 @@ function swigc_TpetraCrsMatrix_hasColMap(farg1) & use, intrinsic :: ISO_C_BINDING import :: swigclasswrapper type(SwigClassWrapper) :: farg1 -logical(C_BOOL) :: fresult +integer(C_INT) :: fresult end function function swigc_TpetraCrsMatrix_isLowerTriangularImpl(farg1) & @@ -3551,7 +3549,7 @@ function swigc_TpetraCrsMatrix_isLowerTriangularImpl(farg1) & use, intrinsic :: ISO_C_BINDING import :: swigclasswrapper type(SwigClassWrapper) :: farg1 -logical(C_BOOL) :: fresult +integer(C_INT) :: fresult end function function swigc_TpetraCrsMatrix_isLowerTriangular(farg1) & @@ -3560,7 +3558,7 @@ function swigc_TpetraCrsMatrix_isLowerTriangular(farg1) & use, intrinsic :: ISO_C_BINDING import :: swigclasswrapper type(SwigClassWrapper) :: farg1 -logical(C_BOOL) :: fresult +integer(C_INT) :: fresult end function function swigc_TpetraCrsMatrix_isUpperTriangularImpl(farg1) & @@ -3569,7 +3567,7 @@ function swigc_TpetraCrsMatrix_isUpperTriangularImpl(farg1) & use, intrinsic :: ISO_C_BINDING import :: swigclasswrapper type(SwigClassWrapper) :: farg1 -logical(C_BOOL) :: fresult +integer(C_INT) :: fresult end function function swigc_TpetraCrsMatrix_isUpperTriangular(farg1) & @@ -3578,7 +3576,7 @@ function swigc_TpetraCrsMatrix_isUpperTriangular(farg1) & use, intrinsic :: ISO_C_BINDING import :: swigclasswrapper type(SwigClassWrapper) :: farg1 -logical(C_BOOL) :: fresult +integer(C_INT) :: fresult end function function swigc_TpetraCrsMatrix_isLocallyIndexed(farg1) & @@ -3587,7 +3585,7 @@ function swigc_TpetraCrsMatrix_isLocallyIndexed(farg1) & use, intrinsic :: ISO_C_BINDING import :: swigclasswrapper type(SwigClassWrapper) :: farg1 -logical(C_BOOL) :: fresult +integer(C_INT) :: fresult end function function swigc_TpetraCrsMatrix_isGloballyIndexed(farg1) & @@ -3596,7 +3594,7 @@ function swigc_TpetraCrsMatrix_isGloballyIndexed(farg1) & use, intrinsic :: ISO_C_BINDING import :: swigclasswrapper type(SwigClassWrapper) :: farg1 -logical(C_BOOL) :: fresult +integer(C_INT) :: fresult end function function swigc_TpetraCrsMatrix_isFillComplete(farg1) & @@ -3605,7 +3603,7 @@ function swigc_TpetraCrsMatrix_isFillComplete(farg1) & use, intrinsic :: ISO_C_BINDING import :: swigclasswrapper type(SwigClassWrapper) :: farg1 -logical(C_BOOL) :: fresult +integer(C_INT) :: fresult end function function swigc_TpetraCrsMatrix_isFillActive(farg1) & @@ -3614,7 +3612,7 @@ function swigc_TpetraCrsMatrix_isFillActive(farg1) & use, intrinsic :: ISO_C_BINDING import :: swigclasswrapper type(SwigClassWrapper) :: farg1 -logical(C_BOOL) :: fresult +integer(C_INT) :: fresult end function function swigc_TpetraCrsMatrix_isStorageOptimized(farg1) & @@ -3623,7 +3621,7 @@ function swigc_TpetraCrsMatrix_isStorageOptimized(farg1) & use, intrinsic :: ISO_C_BINDING import :: swigclasswrapper type(SwigClassWrapper) :: farg1 -logical(C_BOOL) :: fresult +integer(C_INT) :: fresult end function function swigc_TpetraCrsMatrix_getProfileType(farg1) & @@ -3641,7 +3639,7 @@ function swigc_TpetraCrsMatrix_isStaticGraph(farg1) & use, intrinsic :: ISO_C_BINDING import :: swigclasswrapper type(SwigClassWrapper) :: farg1 -logical(C_BOOL) :: fresult +integer(C_INT) :: fresult end function function swigc_TpetraCrsMatrix_getFrobeniusNorm(farg1) & @@ -3659,7 +3657,7 @@ function swigc_TpetraCrsMatrix_supportsRowViews(farg1) & use, intrinsic :: ISO_C_BINDING import :: swigclasswrapper type(SwigClassWrapper) :: farg1 -logical(C_BOOL) :: fresult +integer(C_INT) :: fresult end function subroutine swigc_TpetraCrsMatrix_apply__SWIG_0(farg1, farg2, farg3, farg4, farg5, farg6) & @@ -3710,7 +3708,7 @@ function swigc_TpetraCrsMatrix_hasTransposeApply(farg1) & use, intrinsic :: ISO_C_BINDING import :: swigclasswrapper type(SwigClassWrapper) :: farg1 -logical(C_BOOL) :: fresult +integer(C_INT) :: fresult end function function swigc_TpetraCrsMatrix_getDomainMap(farg1) & @@ -3755,7 +3753,7 @@ subroutine swigc_TpetraCrsMatrix_gaussSeidelCopy(farg1, farg2, farg3, farg4, far real(C_DOUBLE), intent(in) :: farg5 integer(C_INT), intent(in) :: farg6 integer(C_INT), intent(in) :: farg7 -logical(C_BOOL), intent(in) :: farg8 +integer(C_INT), intent(in) :: farg8 end subroutine function swigc_TpetraCrsMatrix_description(farg1) & @@ -3872,7 +3870,7 @@ function swigc_TpetraCrsMatrix_haveGlobalConstants(farg1) & use, intrinsic :: ISO_C_BINDING import :: swigclasswrapper type(SwigClassWrapper) :: farg1 -logical(C_BOOL) :: fresult +integer(C_INT) :: fresult end function function swigc_new_TpetraCrsMatrix__SWIG_10(farg1, farg2, farg3, farg4) & @@ -4166,9 +4164,9 @@ function swigc_TpetraReader_readSparseGraphFile__SWIG_0(farg1, farg2, farg3, far import :: swigarraywrapper type(SwigArrayWrapper) :: farg1 type(SwigClassWrapper) :: farg2 -logical(C_BOOL), intent(in) :: farg3 -logical(C_BOOL), intent(in) :: farg4 -logical(C_BOOL), intent(in) :: farg5 +integer(C_INT), intent(in) :: farg3 +integer(C_INT), intent(in) :: farg4 +integer(C_INT), intent(in) :: farg5 type(SwigClassWrapper) :: fresult end function @@ -4180,8 +4178,8 @@ function swigc_TpetraReader_readSparseGraphFile__SWIG_1(farg1, farg2, farg3, far import :: swigarraywrapper type(SwigArrayWrapper) :: farg1 type(SwigClassWrapper) :: farg2 -logical(C_BOOL), intent(in) :: farg3 -logical(C_BOOL), intent(in) :: farg4 +integer(C_INT), intent(in) :: farg3 +integer(C_INT), intent(in) :: farg4 type(SwigClassWrapper) :: fresult end function @@ -4193,7 +4191,7 @@ function swigc_TpetraReader_readSparseGraphFile__SWIG_2(farg1, farg2, farg3) & import :: swigarraywrapper type(SwigArrayWrapper) :: farg1 type(SwigClassWrapper) :: farg2 -logical(C_BOOL), intent(in) :: farg3 +integer(C_INT), intent(in) :: farg3 type(SwigClassWrapper) :: fresult end function @@ -4218,8 +4216,8 @@ function swigc_TpetraReader_readSparseGraphFile__SWIG_4(farg1, farg2, farg3, far type(SwigClassWrapper) :: farg2 type(SwigClassWrapper) :: farg3 type(SwigClassWrapper) :: farg4 -logical(C_BOOL), intent(in) :: farg5 -logical(C_BOOL), intent(in) :: farg6 +integer(C_INT), intent(in) :: farg5 +integer(C_INT), intent(in) :: farg6 type(SwigClassWrapper) :: fresult end function @@ -4233,7 +4231,7 @@ function swigc_TpetraReader_readSparseGraphFile__SWIG_5(farg1, farg2, farg3, far type(SwigClassWrapper) :: farg2 type(SwigClassWrapper) :: farg3 type(SwigClassWrapper) :: farg4 -logical(C_BOOL), intent(in) :: farg5 +integer(C_INT), intent(in) :: farg5 type(SwigClassWrapper) :: fresult end function @@ -4261,9 +4259,9 @@ function swigc_TpetraReader_readSparseGraphFile__SWIG_7(farg1, farg2, farg3, far type(SwigClassWrapper) :: farg3 type(SwigClassWrapper) :: farg4 type(SwigClassWrapper) :: farg5 -logical(C_BOOL), intent(in) :: farg6 -logical(C_BOOL), intent(in) :: farg7 -logical(C_BOOL), intent(in) :: farg8 +integer(C_INT), intent(in) :: farg6 +integer(C_INT), intent(in) :: farg7 +integer(C_INT), intent(in) :: farg8 type(SwigClassWrapper) :: fresult end function @@ -4278,8 +4276,8 @@ function swigc_TpetraReader_readSparseGraphFile__SWIG_8(farg1, farg2, farg3, far type(SwigClassWrapper) :: farg3 type(SwigClassWrapper) :: farg4 type(SwigClassWrapper) :: farg5 -logical(C_BOOL), intent(in) :: farg6 -logical(C_BOOL), intent(in) :: farg7 +integer(C_INT), intent(in) :: farg6 +integer(C_INT), intent(in) :: farg7 type(SwigClassWrapper) :: fresult end function @@ -4294,7 +4292,7 @@ function swigc_TpetraReader_readSparseGraphFile__SWIG_9(farg1, farg2, farg3, far type(SwigClassWrapper) :: farg3 type(SwigClassWrapper) :: farg4 type(SwigClassWrapper) :: farg5 -logical(C_BOOL), intent(in) :: farg6 +integer(C_INT), intent(in) :: farg6 type(SwigClassWrapper) :: fresult end function @@ -4320,9 +4318,9 @@ function swigc_TpetraReader_readSparseFile__SWIG_0(farg1, farg2, farg3, farg4, f import :: swigarraywrapper type(SwigArrayWrapper) :: farg1 type(SwigClassWrapper) :: farg2 -logical(C_BOOL), intent(in) :: farg3 -logical(C_BOOL), intent(in) :: farg4 -logical(C_BOOL), intent(in) :: farg5 +integer(C_INT), intent(in) :: farg3 +integer(C_INT), intent(in) :: farg4 +integer(C_INT), intent(in) :: farg5 type(SwigClassWrapper) :: fresult end function @@ -4334,8 +4332,8 @@ function swigc_TpetraReader_readSparseFile__SWIG_1(farg1, farg2, farg3, farg4) & import :: swigarraywrapper type(SwigArrayWrapper) :: farg1 type(SwigClassWrapper) :: farg2 -logical(C_BOOL), intent(in) :: farg3 -logical(C_BOOL), intent(in) :: farg4 +integer(C_INT), intent(in) :: farg3 +integer(C_INT), intent(in) :: farg4 type(SwigClassWrapper) :: fresult end function @@ -4347,7 +4345,7 @@ function swigc_TpetraReader_readSparseFile__SWIG_2(farg1, farg2, farg3) & import :: swigarraywrapper type(SwigArrayWrapper) :: farg1 type(SwigClassWrapper) :: farg2 -logical(C_BOOL), intent(in) :: farg3 +integer(C_INT), intent(in) :: farg3 type(SwigClassWrapper) :: fresult end function @@ -4372,8 +4370,8 @@ function swigc_TpetraReader_readSparseFile__SWIG_4(farg1, farg2, farg3, farg4, f type(SwigClassWrapper) :: farg2 type(SwigClassWrapper) :: farg3 type(SwigClassWrapper) :: farg4 -logical(C_BOOL), intent(in) :: farg5 -logical(C_BOOL), intent(in) :: farg6 +integer(C_INT), intent(in) :: farg5 +integer(C_INT), intent(in) :: farg6 type(SwigClassWrapper) :: fresult end function @@ -4387,7 +4385,7 @@ function swigc_TpetraReader_readSparseFile__SWIG_5(farg1, farg2, farg3, farg4, f type(SwigClassWrapper) :: farg2 type(SwigClassWrapper) :: farg3 type(SwigClassWrapper) :: farg4 -logical(C_BOOL), intent(in) :: farg5 +integer(C_INT), intent(in) :: farg5 type(SwigClassWrapper) :: fresult end function @@ -4415,9 +4413,9 @@ function swigc_TpetraReader_readSparseFile__SWIG_7(farg1, farg2, farg3, farg4, f type(SwigClassWrapper) :: farg3 type(SwigClassWrapper) :: farg4 type(SwigClassWrapper) :: farg5 -logical(C_BOOL), intent(in) :: farg6 -logical(C_BOOL), intent(in) :: farg7 -logical(C_BOOL), intent(in) :: farg8 +integer(C_INT), intent(in) :: farg6 +integer(C_INT), intent(in) :: farg7 +integer(C_INT), intent(in) :: farg8 type(SwigClassWrapper) :: fresult end function @@ -4432,8 +4430,8 @@ function swigc_TpetraReader_readSparseFile__SWIG_8(farg1, farg2, farg3, farg4, f type(SwigClassWrapper) :: farg3 type(SwigClassWrapper) :: farg4 type(SwigClassWrapper) :: farg5 -logical(C_BOOL), intent(in) :: farg6 -logical(C_BOOL), intent(in) :: farg7 +integer(C_INT), intent(in) :: farg6 +integer(C_INT), intent(in) :: farg7 type(SwigClassWrapper) :: fresult end function @@ -4448,7 +4446,7 @@ function swigc_TpetraReader_readSparseFile__SWIG_9(farg1, farg2, farg3, farg4, f type(SwigClassWrapper) :: farg3 type(SwigClassWrapper) :: farg4 type(SwigClassWrapper) :: farg5 -logical(C_BOOL), intent(in) :: farg6 +integer(C_INT), intent(in) :: farg6 type(SwigClassWrapper) :: fresult end function @@ -4475,8 +4473,8 @@ function swigc_TpetraReader_readDenseFile__SWIG_0(farg1, farg2, farg3, farg4, fa type(SwigArrayWrapper) :: farg1 type(SwigClassWrapper) :: farg2 type(SwigClassWrapper) :: farg3 -logical(C_BOOL), intent(in) :: farg4 -logical(C_BOOL), intent(in) :: farg5 +integer(C_INT), intent(in) :: farg4 +integer(C_INT), intent(in) :: farg5 type(SwigClassWrapper) :: fresult end function @@ -4489,7 +4487,7 @@ function swigc_TpetraReader_readDenseFile__SWIG_1(farg1, farg2, farg3, farg4) & type(SwigArrayWrapper) :: farg1 type(SwigClassWrapper) :: farg2 type(SwigClassWrapper) :: farg3 -logical(C_BOOL), intent(in) :: farg4 +integer(C_INT), intent(in) :: farg4 type(SwigClassWrapper) :: fresult end function @@ -4513,8 +4511,8 @@ function swigc_TpetraReader_readMapFile__SWIG_0(farg1, farg2, farg3, farg4) & import :: swigarraywrapper type(SwigArrayWrapper) :: farg1 type(SwigClassWrapper) :: farg2 -logical(C_BOOL), intent(in) :: farg3 -logical(C_BOOL), intent(in) :: farg4 +integer(C_INT), intent(in) :: farg3 +integer(C_INT), intent(in) :: farg4 type(SwigClassWrapper) :: fresult end function @@ -4526,7 +4524,7 @@ function swigc_TpetraReader_readMapFile__SWIG_1(farg1, farg2, farg3) & import :: swigarraywrapper type(SwigArrayWrapper) :: farg1 type(SwigClassWrapper) :: farg2 -logical(C_BOOL), intent(in) :: farg3 +integer(C_INT), intent(in) :: farg3 type(SwigClassWrapper) :: fresult end function @@ -4581,7 +4579,7 @@ subroutine swigc_TpetraWriter_writeSparseFile__SWIG_0(farg1, farg2, farg3, farg4 type(SwigClassWrapper) :: farg2 type(SwigArrayWrapper) :: farg3 type(SwigArrayWrapper) :: farg4 -logical(C_BOOL), intent(in) :: farg5 +integer(C_INT), intent(in) :: farg5 end subroutine subroutine swigc_TpetraWriter_writeSparseFile__SWIG_1(farg1, farg2, farg3, farg4) & @@ -4602,7 +4600,7 @@ subroutine swigc_TpetraWriter_writeSparseFile__SWIG_2(farg1, farg2, farg3) & import :: swigclasswrapper type(SwigArrayWrapper) :: farg1 type(SwigClassWrapper) :: farg2 -logical(C_BOOL), intent(in) :: farg3 +integer(C_INT), intent(in) :: farg3 end subroutine subroutine swigc_TpetraWriter_writeSparseFile__SWIG_3(farg1, farg2) & @@ -4623,7 +4621,7 @@ subroutine swigc_TpetraWriter_writeSparseGraphFile__SWIG_0(farg1, farg2, farg3, type(SwigClassWrapper) :: farg2 type(SwigArrayWrapper) :: farg3 type(SwigArrayWrapper) :: farg4 -logical(C_BOOL), intent(in) :: farg5 +integer(C_INT), intent(in) :: farg5 end subroutine subroutine swigc_TpetraWriter_writeSparseGraphFile__SWIG_1(farg1, farg2, farg3, farg4) & @@ -4644,7 +4642,7 @@ subroutine swigc_TpetraWriter_writeSparseGraphFile__SWIG_2(farg1, farg2, farg3) import :: swigclasswrapper type(SwigArrayWrapper) :: farg1 type(SwigClassWrapper) :: farg2 -logical(C_BOOL), intent(in) :: farg3 +integer(C_INT), intent(in) :: farg3 end subroutine subroutine swigc_TpetraWriter_writeSparseGraphFile__SWIG_3(farg1, farg2) & @@ -4704,11 +4702,11 @@ subroutine swigc_TpetraMatrixMatrixMultiply__SWIG_0(farg1, farg2, farg3, farg4, import :: swigclasswrapper import :: swigarraywrapper type(SwigClassWrapper) :: farg1 -logical(C_BOOL), intent(in) :: farg2 +integer(C_INT), intent(in) :: farg2 type(SwigClassWrapper) :: farg3 -logical(C_BOOL), intent(in) :: farg4 +integer(C_INT), intent(in) :: farg4 type(SwigClassWrapper) :: farg5 -logical(C_BOOL), intent(in) :: farg6 +integer(C_INT), intent(in) :: farg6 type(SwigArrayWrapper) :: farg7 type(SwigClassWrapper) :: farg8 end subroutine @@ -4719,11 +4717,11 @@ subroutine swigc_TpetraMatrixMatrixMultiply__SWIG_1(farg1, farg2, farg3, farg4, import :: swigclasswrapper import :: swigarraywrapper type(SwigClassWrapper) :: farg1 -logical(C_BOOL), intent(in) :: farg2 +integer(C_INT), intent(in) :: farg2 type(SwigClassWrapper) :: farg3 -logical(C_BOOL), intent(in) :: farg4 +integer(C_INT), intent(in) :: farg4 type(SwigClassWrapper) :: farg5 -logical(C_BOOL), intent(in) :: farg6 +integer(C_INT), intent(in) :: farg6 type(SwigArrayWrapper) :: farg7 end subroutine @@ -4732,11 +4730,11 @@ subroutine swigc_TpetraMatrixMatrixMultiply__SWIG_2(farg1, farg2, farg3, farg4, use, intrinsic :: ISO_C_BINDING import :: swigclasswrapper type(SwigClassWrapper) :: farg1 -logical(C_BOOL), intent(in) :: farg2 +integer(C_INT), intent(in) :: farg2 type(SwigClassWrapper) :: farg3 -logical(C_BOOL), intent(in) :: farg4 +integer(C_INT), intent(in) :: farg4 type(SwigClassWrapper) :: farg5 -logical(C_BOOL), intent(in) :: farg6 +integer(C_INT), intent(in) :: farg6 end subroutine subroutine swigc_TpetraMatrixMatrixMultiply__SWIG_3(farg1, farg2, farg3, farg4, farg5) & @@ -4744,9 +4742,9 @@ subroutine swigc_TpetraMatrixMatrixMultiply__SWIG_3(farg1, farg2, farg3, farg4, use, intrinsic :: ISO_C_BINDING import :: swigclasswrapper type(SwigClassWrapper) :: farg1 -logical(C_BOOL), intent(in) :: farg2 +integer(C_INT), intent(in) :: farg2 type(SwigClassWrapper) :: farg3 -logical(C_BOOL), intent(in) :: farg4 +integer(C_INT), intent(in) :: farg4 type(SwigClassWrapper) :: farg5 end subroutine @@ -4755,7 +4753,7 @@ subroutine swigc_TpetraMatrixMatrixAdd__SWIG_0(farg1, farg2, farg3, farg4, farg5 use, intrinsic :: ISO_C_BINDING import :: swigclasswrapper type(SwigClassWrapper) :: farg1 -logical(C_BOOL), intent(in) :: farg2 +integer(C_INT), intent(in) :: farg2 real(C_DOUBLE), intent(in) :: farg3 type(SwigClassWrapper) :: farg4 real(C_DOUBLE), intent(in) :: farg5 @@ -4766,10 +4764,10 @@ subroutine swigc_TpetraMatrixMatrixAdd__SWIG_1(farg1, farg2, farg3, farg4, farg5 use, intrinsic :: ISO_C_BINDING import :: swigclasswrapper type(SwigClassWrapper) :: farg1 -logical(C_BOOL), intent(in) :: farg2 +integer(C_INT), intent(in) :: farg2 real(C_DOUBLE), intent(in) :: farg3 type(SwigClassWrapper) :: farg4 -logical(C_BOOL), intent(in) :: farg5 +integer(C_INT), intent(in) :: farg5 real(C_DOUBLE), intent(in) :: farg6 type(SwigClassWrapper) :: farg7 end subroutine @@ -4866,18 +4864,31 @@ subroutine delete_TpetraMap(self) self%swigdata%mem = SWIG_NULL end subroutine + +function SWIG_int_to_logical(inp) & + result(out) + use, intrinsic :: ISO_C_BINDING + integer(kind=C_INT), intent(IN) :: inp + logical :: out + if (inp /= 0) then + out = .true. + else + out = .false. + end if +end function + function swigf_TpetraMap_isOneToOne(self) & result(swig_result) use, intrinsic :: ISO_C_BINDING -logical(C_BOOL) :: swig_result +logical :: swig_result class(TpetraMap), intent(in) :: self -logical(C_BOOL) :: fresult +integer(C_INT) :: fresult type(SwigClassWrapper) :: farg1 farg1 = self%swigdata fresult = swigc_TpetraMap_isOneToOne(farg1) -swig_result = fresult +swig_result = SWIG_int_to_logical(fresult) end function function swigf_TpetraMap_getGlobalNumElements(self) & @@ -5031,151 +5042,151 @@ function swigf_TpetraMap_getGlobalElement(self, localindex) & function swigf_TpetraMap_isNodeLocalElement(self, localindex) & result(swig_result) use, intrinsic :: ISO_C_BINDING -logical(C_BOOL) :: swig_result +logical :: swig_result class(TpetraMap), intent(in) :: self integer(C_INT), intent(in) :: localindex -logical(C_BOOL) :: fresult +integer(C_INT) :: fresult type(SwigClassWrapper) :: farg1 integer(C_INT) :: farg2 farg1 = self%swigdata farg2 = localindex fresult = swigc_TpetraMap_isNodeLocalElement(farg1, farg2) -swig_result = fresult +swig_result = SWIG_int_to_logical(fresult) end function function swigf_TpetraMap_isNodeGlobalElement(self, globalindex) & result(swig_result) use, intrinsic :: ISO_C_BINDING -logical(C_BOOL) :: swig_result +logical :: swig_result class(TpetraMap), intent(in) :: self integer(C_LONG_LONG), intent(in) :: globalindex -logical(C_BOOL) :: fresult +integer(C_INT) :: fresult type(SwigClassWrapper) :: farg1 integer(C_LONG_LONG) :: farg2 farg1 = self%swigdata farg2 = globalindex fresult = swigc_TpetraMap_isNodeGlobalElement(farg1, farg2) -swig_result = fresult +swig_result = SWIG_int_to_logical(fresult) end function function swigf_TpetraMap_isUniform(self) & result(swig_result) use, intrinsic :: ISO_C_BINDING -logical(C_BOOL) :: swig_result +logical :: swig_result class(TpetraMap), intent(in) :: self -logical(C_BOOL) :: fresult +integer(C_INT) :: fresult type(SwigClassWrapper) :: farg1 farg1 = self%swigdata fresult = swigc_TpetraMap_isUniform(farg1) -swig_result = fresult +swig_result = SWIG_int_to_logical(fresult) end function function swigf_TpetraMap_isContiguous(self) & result(swig_result) use, intrinsic :: ISO_C_BINDING -logical(C_BOOL) :: swig_result +logical :: swig_result class(TpetraMap), intent(in) :: self -logical(C_BOOL) :: fresult +integer(C_INT) :: fresult type(SwigClassWrapper) :: farg1 farg1 = self%swigdata fresult = swigc_TpetraMap_isContiguous(farg1) -swig_result = fresult +swig_result = SWIG_int_to_logical(fresult) end function function swigf_TpetraMap_isDistributed(self) & result(swig_result) use, intrinsic :: ISO_C_BINDING -logical(C_BOOL) :: swig_result +logical :: swig_result class(TpetraMap), intent(in) :: self -logical(C_BOOL) :: fresult +integer(C_INT) :: fresult type(SwigClassWrapper) :: farg1 farg1 = self%swigdata fresult = swigc_TpetraMap_isDistributed(farg1) -swig_result = fresult +swig_result = SWIG_int_to_logical(fresult) end function function swigf_TpetraMap_isCompatible(self, map) & result(swig_result) use, intrinsic :: ISO_C_BINDING -logical(C_BOOL) :: swig_result +logical :: swig_result class(TpetraMap), intent(in) :: self class(TpetraMap), intent(in) :: map -logical(C_BOOL) :: fresult +integer(C_INT) :: fresult type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 farg1 = self%swigdata farg2 = map%swigdata fresult = swigc_TpetraMap_isCompatible(farg1, farg2) -swig_result = fresult +swig_result = SWIG_int_to_logical(fresult) end function function swigf_TpetraMap_isSameAs(self, map) & result(swig_result) use, intrinsic :: ISO_C_BINDING -logical(C_BOOL) :: swig_result +logical :: swig_result class(TpetraMap), intent(in) :: self class(TpetraMap), intent(in) :: map -logical(C_BOOL) :: fresult +integer(C_INT) :: fresult type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 farg1 = self%swigdata farg2 = map%swigdata fresult = swigc_TpetraMap_isSameAs(farg1, farg2) -swig_result = fresult +swig_result = SWIG_int_to_logical(fresult) end function function swigf_TpetraMap_locallySameAs(self, map) & result(swig_result) use, intrinsic :: ISO_C_BINDING -logical(C_BOOL) :: swig_result +logical :: swig_result class(TpetraMap), intent(in) :: self class(TpetraMap), intent(in) :: map -logical(C_BOOL) :: fresult +integer(C_INT) :: fresult type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 farg1 = self%swigdata farg2 = map%swigdata fresult = swigc_TpetraMap_locallySameAs(farg1, farg2) -swig_result = fresult +swig_result = SWIG_int_to_logical(fresult) end function function swigf_TpetraMap_isLocallyFitted(self, map) & result(swig_result) use, intrinsic :: ISO_C_BINDING -logical(C_BOOL) :: swig_result +logical :: swig_result class(TpetraMap), intent(in) :: self class(TpetraMap), intent(in) :: map -logical(C_BOOL) :: fresult +integer(C_INT) :: fresult type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 farg1 = self%swigdata farg2 = map%swigdata fresult = swigc_TpetraMap_isLocallyFitted(farg1, farg2) -swig_result = fresult +swig_result = SWIG_int_to_logical(fresult) end function function swigf_TpetraMap_getComm(self) & @@ -5583,15 +5594,15 @@ function swigf_TpetraExport_getTargetMap(self) & function swigf_TpetraExport_isLocallyComplete(self) & result(swig_result) use, intrinsic :: ISO_C_BINDING -logical(C_BOOL) :: swig_result +logical :: swig_result class(TpetraExport), intent(in) :: self -logical(C_BOOL) :: fresult +integer(C_INT) :: fresult type(SwigClassWrapper) :: farg1 farg1 = self%swigdata fresult = swigc_TpetraExport_isLocallyComplete(farg1) -swig_result = fresult +swig_result = SWIG_int_to_logical(fresult) end function subroutine swigf_assignment_TpetraExport(self, other) @@ -5783,15 +5794,15 @@ function swigf_TpetraImport_getTargetMap(self) & function swigf_TpetraImport_isLocallyComplete(self) & result(swig_result) use, intrinsic :: ISO_C_BINDING -logical(C_BOOL) :: swig_result +logical :: swig_result class(TpetraImport), intent(in) :: self -logical(C_BOOL) :: fresult +integer(C_INT) :: fresult type(SwigClassWrapper) :: farg1 farg1 = self%swigdata fresult = swigc_TpetraImport_isLocallyComplete(farg1) -swig_result = fresult +swig_result = SWIG_int_to_logical(fresult) end function function swigf_TpetraImport_setUnion__SWIG_0(self, rhs) & @@ -5861,6 +5872,19 @@ function new_TpetraMultiVector__SWIG_0() & self%swigdata = fresult end function + +function SWIG_logical_to_int(inp) & + result(out) + use, intrinsic :: ISO_C_BINDING + logical, intent(IN) :: inp + integer(kind=C_INT) :: out + if (inp .eqv. .true.) then + out = 1 + else + out = 0 + end if +end function + function new_TpetraMultiVector__SWIG_1(map, numvecs, zeroout) & result(self) use, intrinsic :: ISO_C_BINDING @@ -5868,16 +5892,16 @@ function new_TpetraMultiVector__SWIG_1(map, numvecs, zeroout) & class(TpetraMap), intent(in) :: map integer(C_SIZE_T), intent(in) :: numvecs -logical(C_BOOL), intent(in) :: zeroout +logical, intent(in) :: zeroout type(SwigClassWrapper) :: fresult type(SwigClassWrapper) :: farg1 integer(C_SIZE_T) :: farg2 -logical(C_BOOL) :: farg3 +integer(C_INT) :: farg3 farg1 = map%swigdata farg2 = numvecs -farg3 = zeroout +farg3 = SWIG_logical_to_int(zeroout) fresult = swigc_new_TpetraMultiVector__SWIG_1(farg1, farg2, farg3) self%swigdata = fresult end function @@ -6027,19 +6051,19 @@ subroutine swigf_TpetraMultiVector_sumIntoGlobalValue__SWIG_0(self, gblrow, col, integer(C_LONG_LONG), intent(in) :: gblrow integer(C_SIZE_T), intent(in) :: col real(C_DOUBLE), intent(in) :: value -logical(C_BOOL), intent(in) :: atomic +logical, intent(in) :: atomic type(SwigClassWrapper) :: farg1 integer(C_LONG_LONG) :: farg2 integer(C_SIZE_T) :: farg3 real(C_DOUBLE) :: farg4 -logical(C_BOOL) :: farg5 +integer(C_INT) :: farg5 farg1 = self%swigdata farg2 = gblrow farg3 = col farg4 = value -farg5 = atomic +farg5 = SWIG_logical_to_int(atomic) call swigc_TpetraMultiVector_sumIntoGlobalValue__SWIG_0(farg1, farg2, farg3, farg4, farg5) end subroutine @@ -6090,19 +6114,19 @@ subroutine swigf_TpetraMultiVector_sumIntoLocalValue__SWIG_0(self, lclrow, col, integer(C_INT), intent(in) :: lclrow integer(C_SIZE_T), intent(in) :: col real(C_DOUBLE), intent(in) :: val -logical(C_BOOL), intent(in) :: atomic +logical, intent(in) :: atomic type(SwigClassWrapper) :: farg1 integer(C_INT) :: farg2 integer(C_SIZE_T) :: farg3 real(C_DOUBLE) :: farg4 -logical(C_BOOL) :: farg5 +integer(C_INT) :: farg5 farg1 = self%swigdata farg2 = lclrow farg3 = col farg4 = val -farg5 = atomic +farg5 = SWIG_logical_to_int(atomic) call swigc_TpetraMultiVector_sumIntoLocalValue__SWIG_0(farg1, farg2, farg3, farg4, farg5) end subroutine @@ -6258,29 +6282,29 @@ subroutine swigf_TpetraMultiVector_sync_device(self) function swigf_TpetraMultiVector_need_sync_host(self) & result(swig_result) use, intrinsic :: ISO_C_BINDING -logical(C_BOOL) :: swig_result +logical :: swig_result class(TpetraMultiVector), intent(in) :: self -logical(C_BOOL) :: fresult +integer(C_INT) :: fresult type(SwigClassWrapper) :: farg1 farg1 = self%swigdata fresult = swigc_TpetraMultiVector_need_sync_host(farg1) -swig_result = fresult +swig_result = SWIG_int_to_logical(fresult) end function function swigf_TpetraMultiVector_need_sync_device(self) & result(swig_result) use, intrinsic :: ISO_C_BINDING -logical(C_BOOL) :: swig_result +logical :: swig_result class(TpetraMultiVector), intent(in) :: self -logical(C_BOOL) :: fresult +integer(C_INT) :: fresult type(SwigClassWrapper) :: farg1 farg1 = self%swigdata fresult = swigc_TpetraMultiVector_need_sync_device(farg1) -swig_result = fresult +swig_result = SWIG_int_to_logical(fresult) end function subroutine swigf_TpetraMultiVector_modify_device(self) @@ -6501,15 +6525,15 @@ function swigf_TpetraMultiVector_getStride(self) & function swigf_TpetraMultiVector_isConstantStride(self) & result(swig_result) use, intrinsic :: ISO_C_BINDING -logical(C_BOOL) :: swig_result +logical :: swig_result class(TpetraMultiVector), intent(in) :: self -logical(C_BOOL) :: fresult +integer(C_INT) :: fresult type(SwigClassWrapper) :: farg1 farg1 = self%swigdata fresult = swigc_TpetraMultiVector_isConstantStride(farg1) -swig_result = fresult +swig_result = SWIG_int_to_logical(fresult) end function function swigf_TpetraMultiVector_description(self) & @@ -6572,19 +6596,19 @@ function swigf_TpetraMultiVector_getCopyOrView(self) & function swigf_TpetraMultiVector_isSameSize(self, vec) & result(swig_result) use, intrinsic :: ISO_C_BINDING -logical(C_BOOL) :: swig_result +logical :: swig_result class(TpetraMultiVector), intent(in) :: self class(TpetraMultiVector), intent(in) :: vec -logical(C_BOOL) :: fresult +integer(C_INT) :: fresult type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 farg1 = self%swigdata farg2 = vec%swigdata fresult = swigc_TpetraMultiVector_isSameSize(farg1, farg2) -swig_result = fresult +swig_result = SWIG_int_to_logical(fresult) end function function new_TpetraMultiVector__SWIG_8(map, a, lda, numvectors) & @@ -7538,19 +7562,19 @@ subroutine swigf_TpetraCrsGraph_swap(self, graph) function swigf_TpetraCrsGraph_isIdenticalTo(self, graph) & result(swig_result) use, intrinsic :: ISO_C_BINDING -logical(C_BOOL) :: swig_result +logical :: swig_result class(TpetraCrsGraph), intent(in) :: self class(TpetraCrsGraph), intent(in) :: graph -logical(C_BOOL) :: fresult +integer(C_INT) :: fresult type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 farg1 = self%swigdata farg2 = graph%swigdata fresult = swigc_TpetraCrsGraph_isIdenticalTo(farg1, farg2) -swig_result = fresult +swig_result = SWIG_int_to_logical(fresult) end function subroutine swigf_TpetraCrsGraph_setParameterList(self, params) @@ -8164,155 +8188,155 @@ function swigf_TpetraCrsGraph_getNodeMaxNumRowEntries(self) & function swigf_TpetraCrsGraph_hasColMap(self) & result(swig_result) use, intrinsic :: ISO_C_BINDING -logical(C_BOOL) :: swig_result +logical :: swig_result class(TpetraCrsGraph), intent(in) :: self -logical(C_BOOL) :: fresult +integer(C_INT) :: fresult type(SwigClassWrapper) :: farg1 farg1 = self%swigdata fresult = swigc_TpetraCrsGraph_hasColMap(farg1) -swig_result = fresult +swig_result = SWIG_int_to_logical(fresult) end function function swigf_TpetraCrsGraph_isLowerTriangularImpl(self) & result(swig_result) use, intrinsic :: ISO_C_BINDING -logical(C_BOOL) :: swig_result +logical :: swig_result class(TpetraCrsGraph), intent(in) :: self -logical(C_BOOL) :: fresult +integer(C_INT) :: fresult type(SwigClassWrapper) :: farg1 farg1 = self%swigdata fresult = swigc_TpetraCrsGraph_isLowerTriangularImpl(farg1) -swig_result = fresult +swig_result = SWIG_int_to_logical(fresult) end function function swigf_TpetraCrsGraph_isLowerTriangular(self) & result(swig_result) use, intrinsic :: ISO_C_BINDING -logical(C_BOOL) :: swig_result +logical :: swig_result class(TpetraCrsGraph), intent(in) :: self -logical(C_BOOL) :: fresult +integer(C_INT) :: fresult type(SwigClassWrapper) :: farg1 farg1 = self%swigdata fresult = swigc_TpetraCrsGraph_isLowerTriangular(farg1) -swig_result = fresult +swig_result = SWIG_int_to_logical(fresult) end function function swigf_TpetraCrsGraph_isUpperTriangularImpl(self) & result(swig_result) use, intrinsic :: ISO_C_BINDING -logical(C_BOOL) :: swig_result +logical :: swig_result class(TpetraCrsGraph), intent(in) :: self -logical(C_BOOL) :: fresult +integer(C_INT) :: fresult type(SwigClassWrapper) :: farg1 farg1 = self%swigdata fresult = swigc_TpetraCrsGraph_isUpperTriangularImpl(farg1) -swig_result = fresult +swig_result = SWIG_int_to_logical(fresult) end function function swigf_TpetraCrsGraph_isUpperTriangular(self) & result(swig_result) use, intrinsic :: ISO_C_BINDING -logical(C_BOOL) :: swig_result +logical :: swig_result class(TpetraCrsGraph), intent(in) :: self -logical(C_BOOL) :: fresult +integer(C_INT) :: fresult type(SwigClassWrapper) :: farg1 farg1 = self%swigdata fresult = swigc_TpetraCrsGraph_isUpperTriangular(farg1) -swig_result = fresult +swig_result = SWIG_int_to_logical(fresult) end function function swigf_TpetraCrsGraph_isLocallyIndexed(self) & result(swig_result) use, intrinsic :: ISO_C_BINDING -logical(C_BOOL) :: swig_result +logical :: swig_result class(TpetraCrsGraph), intent(in) :: self -logical(C_BOOL) :: fresult +integer(C_INT) :: fresult type(SwigClassWrapper) :: farg1 farg1 = self%swigdata fresult = swigc_TpetraCrsGraph_isLocallyIndexed(farg1) -swig_result = fresult +swig_result = SWIG_int_to_logical(fresult) end function function swigf_TpetraCrsGraph_isGloballyIndexed(self) & result(swig_result) use, intrinsic :: ISO_C_BINDING -logical(C_BOOL) :: swig_result +logical :: swig_result class(TpetraCrsGraph), intent(in) :: self -logical(C_BOOL) :: fresult +integer(C_INT) :: fresult type(SwigClassWrapper) :: farg1 farg1 = self%swigdata fresult = swigc_TpetraCrsGraph_isGloballyIndexed(farg1) -swig_result = fresult +swig_result = SWIG_int_to_logical(fresult) end function function swigf_TpetraCrsGraph_isFillComplete(self) & result(swig_result) use, intrinsic :: ISO_C_BINDING -logical(C_BOOL) :: swig_result +logical :: swig_result class(TpetraCrsGraph), intent(in) :: self -logical(C_BOOL) :: fresult +integer(C_INT) :: fresult type(SwigClassWrapper) :: farg1 farg1 = self%swigdata fresult = swigc_TpetraCrsGraph_isFillComplete(farg1) -swig_result = fresult +swig_result = SWIG_int_to_logical(fresult) end function function swigf_TpetraCrsGraph_isFillActive(self) & result(swig_result) use, intrinsic :: ISO_C_BINDING -logical(C_BOOL) :: swig_result +logical :: swig_result class(TpetraCrsGraph), intent(in) :: self -logical(C_BOOL) :: fresult +integer(C_INT) :: fresult type(SwigClassWrapper) :: farg1 farg1 = self%swigdata fresult = swigc_TpetraCrsGraph_isFillActive(farg1) -swig_result = fresult +swig_result = SWIG_int_to_logical(fresult) end function function swigf_TpetraCrsGraph_isSorted(self) & result(swig_result) use, intrinsic :: ISO_C_BINDING -logical(C_BOOL) :: swig_result +logical :: swig_result class(TpetraCrsGraph), intent(in) :: self -logical(C_BOOL) :: fresult +integer(C_INT) :: fresult type(SwigClassWrapper) :: farg1 farg1 = self%swigdata fresult = swigc_TpetraCrsGraph_isSorted(farg1) -swig_result = fresult +swig_result = SWIG_int_to_logical(fresult) end function function swigf_TpetraCrsGraph_isStorageOptimized(self) & result(swig_result) use, intrinsic :: ISO_C_BINDING -logical(C_BOOL) :: swig_result +logical :: swig_result class(TpetraCrsGraph), intent(in) :: self -logical(C_BOOL) :: fresult +integer(C_INT) :: fresult type(SwigClassWrapper) :: farg1 farg1 = self%swigdata fresult = swigc_TpetraCrsGraph_isStorageOptimized(farg1) -swig_result = fresult +swig_result = SWIG_int_to_logical(fresult) end function function swigf_TpetraCrsGraph_getProfileType(self) & @@ -8332,15 +8356,15 @@ function swigf_TpetraCrsGraph_getProfileType(self) & function swigf_TpetraCrsGraph_supportsRowViews(self) & result(swig_result) use, intrinsic :: ISO_C_BINDING -logical(C_BOOL) :: swig_result +logical :: swig_result class(TpetraCrsGraph), intent(in) :: self -logical(C_BOOL) :: fresult +integer(C_INT) :: fresult type(SwigClassWrapper) :: farg1 farg1 = self%swigdata fresult = swigc_TpetraCrsGraph_supportsRowViews(farg1) -swig_result = fresult +swig_result = SWIG_int_to_logical(fresult) end function function swigf_TpetraCrsGraph_description(self) & @@ -8380,17 +8404,17 @@ subroutine swigf_TpetraCrsGraph_reindexColumns__SWIG_0(self, newcolmap, newimpor class(TpetraImport), intent(in) :: newimport -logical(C_BOOL), intent(in) :: sortindicesineachrow +logical, intent(in) :: sortindicesineachrow type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 type(SwigClassWrapper) :: farg3 -logical(C_BOOL) :: farg4 +integer(C_INT) :: farg4 farg1 = self%swigdata farg2 = newcolmap%swigdata farg3 = newimport%swigdata -farg4 = sortindicesineachrow +farg4 = SWIG_logical_to_int(sortindicesineachrow) call swigc_TpetraCrsGraph_reindexColumns__SWIG_0(farg1, farg2, farg3, farg4) end subroutine @@ -8683,28 +8707,28 @@ subroutine swigf_TpetraCrsGraph_exportAndFillComplete__SWIG_4(self, destgraph, r function swigf_TpetraCrsGraph_haveGlobalConstants(self) & result(swig_result) use, intrinsic :: ISO_C_BINDING -logical(C_BOOL) :: swig_result +logical :: swig_result class(TpetraCrsGraph), intent(in) :: self -logical(C_BOOL) :: fresult +integer(C_INT) :: fresult type(SwigClassWrapper) :: farg1 farg1 = self%swigdata fresult = swigc_TpetraCrsGraph_haveGlobalConstants(farg1) -swig_result = fresult +swig_result = SWIG_int_to_logical(fresult) end function subroutine swigf_TpetraCrsGraph_computeGlobalConstants(self, computelocaltriangularconstants) use, intrinsic :: ISO_C_BINDING class(TpetraCrsGraph), intent(inout) :: self -logical(C_BOOL), intent(in) :: computelocaltriangularconstants +logical, intent(in) :: computelocaltriangularconstants type(SwigClassWrapper) :: farg1 -logical(C_BOOL) :: farg2 +integer(C_INT) :: farg2 farg1 = self%swigdata -farg2 = computelocaltriangularconstants +farg2 = SWIG_logical_to_int(computelocaltriangularconstants) call swigc_TpetraCrsGraph_computeGlobalConstants(farg1, farg2) end subroutine @@ -9679,19 +9703,19 @@ subroutine swigf_TpetraCrsMatrix_reindexColumns__SWIG_0(self, graph, newcolmap, class(TpetraImport), intent(in) :: newimport -logical(C_BOOL), intent(in) :: sorteachrow +logical, intent(in) :: sorteachrow type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 type(SwigClassWrapper) :: farg3 type(SwigClassWrapper) :: farg4 -logical(C_BOOL) :: farg5 +integer(C_INT) :: farg5 farg1 = self%swigdata farg2 = graph%swigdata farg3 = newcolmap%swigdata farg4 = newimport%swigdata -farg5 = sorteachrow +farg5 = SWIG_logical_to_int(sorteachrow) call swigc_TpetraCrsMatrix_reindexColumns__SWIG_0(farg1, farg2, farg3, farg4, farg5) end subroutine @@ -10030,141 +10054,141 @@ function swigf_TpetraCrsMatrix_getNodeMaxNumRowEntries(self) & function swigf_TpetraCrsMatrix_hasColMap(self) & result(swig_result) use, intrinsic :: ISO_C_BINDING -logical(C_BOOL) :: swig_result +logical :: swig_result class(TpetraCrsMatrix), intent(in) :: self -logical(C_BOOL) :: fresult +integer(C_INT) :: fresult type(SwigClassWrapper) :: farg1 farg1 = self%swigdata fresult = swigc_TpetraCrsMatrix_hasColMap(farg1) -swig_result = fresult +swig_result = SWIG_int_to_logical(fresult) end function function swigf_TpetraCrsMatrix_isLowerTriangularImpl(self) & result(swig_result) use, intrinsic :: ISO_C_BINDING -logical(C_BOOL) :: swig_result +logical :: swig_result class(TpetraCrsMatrix), intent(in) :: self -logical(C_BOOL) :: fresult +integer(C_INT) :: fresult type(SwigClassWrapper) :: farg1 farg1 = self%swigdata fresult = swigc_TpetraCrsMatrix_isLowerTriangularImpl(farg1) -swig_result = fresult +swig_result = SWIG_int_to_logical(fresult) end function function swigf_TpetraCrsMatrix_isLowerTriangular(self) & result(swig_result) use, intrinsic :: ISO_C_BINDING -logical(C_BOOL) :: swig_result +logical :: swig_result class(TpetraCrsMatrix), intent(in) :: self -logical(C_BOOL) :: fresult +integer(C_INT) :: fresult type(SwigClassWrapper) :: farg1 farg1 = self%swigdata fresult = swigc_TpetraCrsMatrix_isLowerTriangular(farg1) -swig_result = fresult +swig_result = SWIG_int_to_logical(fresult) end function function swigf_TpetraCrsMatrix_isUpperTriangularImpl(self) & result(swig_result) use, intrinsic :: ISO_C_BINDING -logical(C_BOOL) :: swig_result +logical :: swig_result class(TpetraCrsMatrix), intent(in) :: self -logical(C_BOOL) :: fresult +integer(C_INT) :: fresult type(SwigClassWrapper) :: farg1 farg1 = self%swigdata fresult = swigc_TpetraCrsMatrix_isUpperTriangularImpl(farg1) -swig_result = fresult +swig_result = SWIG_int_to_logical(fresult) end function function swigf_TpetraCrsMatrix_isUpperTriangular(self) & result(swig_result) use, intrinsic :: ISO_C_BINDING -logical(C_BOOL) :: swig_result +logical :: swig_result class(TpetraCrsMatrix), intent(in) :: self -logical(C_BOOL) :: fresult +integer(C_INT) :: fresult type(SwigClassWrapper) :: farg1 farg1 = self%swigdata fresult = swigc_TpetraCrsMatrix_isUpperTriangular(farg1) -swig_result = fresult +swig_result = SWIG_int_to_logical(fresult) end function function swigf_TpetraCrsMatrix_isLocallyIndexed(self) & result(swig_result) use, intrinsic :: ISO_C_BINDING -logical(C_BOOL) :: swig_result +logical :: swig_result class(TpetraCrsMatrix), intent(in) :: self -logical(C_BOOL) :: fresult +integer(C_INT) :: fresult type(SwigClassWrapper) :: farg1 farg1 = self%swigdata fresult = swigc_TpetraCrsMatrix_isLocallyIndexed(farg1) -swig_result = fresult +swig_result = SWIG_int_to_logical(fresult) end function function swigf_TpetraCrsMatrix_isGloballyIndexed(self) & result(swig_result) use, intrinsic :: ISO_C_BINDING -logical(C_BOOL) :: swig_result +logical :: swig_result class(TpetraCrsMatrix), intent(in) :: self -logical(C_BOOL) :: fresult +integer(C_INT) :: fresult type(SwigClassWrapper) :: farg1 farg1 = self%swigdata fresult = swigc_TpetraCrsMatrix_isGloballyIndexed(farg1) -swig_result = fresult +swig_result = SWIG_int_to_logical(fresult) end function function swigf_TpetraCrsMatrix_isFillComplete(self) & result(swig_result) use, intrinsic :: ISO_C_BINDING -logical(C_BOOL) :: swig_result +logical :: swig_result class(TpetraCrsMatrix), intent(in) :: self -logical(C_BOOL) :: fresult +integer(C_INT) :: fresult type(SwigClassWrapper) :: farg1 farg1 = self%swigdata fresult = swigc_TpetraCrsMatrix_isFillComplete(farg1) -swig_result = fresult +swig_result = SWIG_int_to_logical(fresult) end function function swigf_TpetraCrsMatrix_isFillActive(self) & result(swig_result) use, intrinsic :: ISO_C_BINDING -logical(C_BOOL) :: swig_result +logical :: swig_result class(TpetraCrsMatrix), intent(in) :: self -logical(C_BOOL) :: fresult +integer(C_INT) :: fresult type(SwigClassWrapper) :: farg1 farg1 = self%swigdata fresult = swigc_TpetraCrsMatrix_isFillActive(farg1) -swig_result = fresult +swig_result = SWIG_int_to_logical(fresult) end function function swigf_TpetraCrsMatrix_isStorageOptimized(self) & result(swig_result) use, intrinsic :: ISO_C_BINDING -logical(C_BOOL) :: swig_result +logical :: swig_result class(TpetraCrsMatrix), intent(in) :: self -logical(C_BOOL) :: fresult +integer(C_INT) :: fresult type(SwigClassWrapper) :: farg1 farg1 = self%swigdata fresult = swigc_TpetraCrsMatrix_isStorageOptimized(farg1) -swig_result = fresult +swig_result = SWIG_int_to_logical(fresult) end function function swigf_TpetraCrsMatrix_getProfileType(self) & @@ -10184,15 +10208,15 @@ function swigf_TpetraCrsMatrix_getProfileType(self) & function swigf_TpetraCrsMatrix_isStaticGraph(self) & result(swig_result) use, intrinsic :: ISO_C_BINDING -logical(C_BOOL) :: swig_result +logical :: swig_result class(TpetraCrsMatrix), intent(in) :: self -logical(C_BOOL) :: fresult +integer(C_INT) :: fresult type(SwigClassWrapper) :: farg1 farg1 = self%swigdata fresult = swigc_TpetraCrsMatrix_isStaticGraph(farg1) -swig_result = fresult +swig_result = SWIG_int_to_logical(fresult) end function function swigf_TpetraCrsMatrix_getFrobeniusNorm(self) & @@ -10212,15 +10236,15 @@ function swigf_TpetraCrsMatrix_getFrobeniusNorm(self) & function swigf_TpetraCrsMatrix_supportsRowViews(self) & result(swig_result) use, intrinsic :: ISO_C_BINDING -logical(C_BOOL) :: swig_result +logical :: swig_result class(TpetraCrsMatrix), intent(in) :: self -logical(C_BOOL) :: fresult +integer(C_INT) :: fresult type(SwigClassWrapper) :: farg1 farg1 = self%swigdata fresult = swigc_TpetraCrsMatrix_supportsRowViews(farg1) -swig_result = fresult +swig_result = SWIG_int_to_logical(fresult) end function subroutine swigf_TpetraCrsMatrix_apply__SWIG_0(self, x, y, mode, alpha, beta) @@ -10319,15 +10343,15 @@ subroutine swigf_TpetraCrsMatrix_apply__SWIG_3(self, x, y) function swigf_TpetraCrsMatrix_hasTransposeApply(self) & result(swig_result) use, intrinsic :: ISO_C_BINDING -logical(C_BOOL) :: swig_result +logical :: swig_result class(TpetraCrsMatrix), intent(in) :: self -logical(C_BOOL) :: fresult +integer(C_INT) :: fresult type(SwigClassWrapper) :: farg1 farg1 = self%swigdata fresult = swigc_TpetraCrsMatrix_hasTransposeApply(farg1) -swig_result = fresult +swig_result = SWIG_int_to_logical(fresult) end function function swigf_TpetraCrsMatrix_getDomainMap(self) & @@ -10403,7 +10427,7 @@ subroutine swigf_TpetraCrsMatrix_gaussSeidelCopy(self, x, b, d, dampingfactor, d real(C_DOUBLE), intent(in) :: dampingfactor integer(TpetraESweepDirection), intent(in) :: direction integer(C_INT), intent(in) :: numsweeps -logical(C_BOOL), intent(in) :: zeroinitialguess +logical, intent(in) :: zeroinitialguess type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 @@ -10412,7 +10436,7 @@ subroutine swigf_TpetraCrsMatrix_gaussSeidelCopy(self, x, b, d, dampingfactor, d real(C_DOUBLE) :: farg5 integer(C_INT) :: farg6 integer(C_INT) :: farg7 -logical(C_BOOL) :: farg8 +integer(C_INT) :: farg8 farg1 = self%swigdata farg2 = x%swigdata @@ -10421,7 +10445,7 @@ subroutine swigf_TpetraCrsMatrix_gaussSeidelCopy(self, x, b, d, dampingfactor, d farg5 = dampingfactor farg6 = direction farg7 = numsweeps -farg8 = zeroinitialguess +farg8 = SWIG_logical_to_int(zeroinitialguess) call swigc_TpetraCrsMatrix_gaussSeidelCopy(farg1, farg2, farg3, farg4, farg5, farg6, farg7, farg8) end subroutine @@ -10675,15 +10699,15 @@ subroutine swigf_TpetraCrsMatrix_computeGlobalConstants(self) function swigf_TpetraCrsMatrix_haveGlobalConstants(self) & result(swig_result) use, intrinsic :: ISO_C_BINDING -logical(C_BOOL) :: swig_result +logical :: swig_result class(TpetraCrsMatrix), intent(in) :: self -logical(C_BOOL) :: fresult +integer(C_INT) :: fresult type(SwigClassWrapper) :: farg1 farg1 = self%swigdata fresult = swigc_TpetraCrsMatrix_haveGlobalConstants(farg1) -swig_result = fresult +swig_result = SWIG_int_to_logical(fresult) end function function new_TpetraCrsMatrix__SWIG_10(rowmap, numentriesperrowtoalloc, pftype, params) & @@ -11320,22 +11344,22 @@ function TpetraReader_readSparseGraphFile__SWIG_0(filename, pcomm, callfillcompl character(kind=C_CHAR), dimension(:), allocatable, target :: farg1_chars class(TeuchosComm), intent(in) :: pcomm -logical(C_BOOL), intent(in) :: callfillcomplete -logical(C_BOOL), intent(in) :: tolerant -logical(C_BOOL), intent(in) :: debug +logical, intent(in) :: callfillcomplete +logical, intent(in) :: tolerant +logical, intent(in) :: debug type(SwigClassWrapper) :: fresult type(SwigArrayWrapper) :: farg1 type(SwigClassWrapper) :: farg2 -logical(C_BOOL) :: farg3 -logical(C_BOOL) :: farg4 -logical(C_BOOL) :: farg5 +integer(C_INT) :: farg3 +integer(C_INT) :: farg4 +integer(C_INT) :: farg5 call SWIG_string_to_chararray(filename, farg1_chars, farg1) farg2 = pcomm%swigdata -farg3 = callfillcomplete -farg4 = tolerant -farg5 = debug +farg3 = SWIG_logical_to_int(callfillcomplete) +farg4 = SWIG_logical_to_int(tolerant) +farg5 = SWIG_logical_to_int(debug) fresult = swigc_TpetraReader_readSparseGraphFile__SWIG_0(farg1, farg2, farg3, farg4, farg5) swig_result%swigdata = fresult end function @@ -11348,19 +11372,19 @@ function TpetraReader_readSparseGraphFile__SWIG_1(filename, pcomm, callfillcompl character(kind=C_CHAR), dimension(:), allocatable, target :: farg1_chars class(TeuchosComm), intent(in) :: pcomm -logical(C_BOOL), intent(in) :: callfillcomplete -logical(C_BOOL), intent(in) :: tolerant +logical, intent(in) :: callfillcomplete +logical, intent(in) :: tolerant type(SwigClassWrapper) :: fresult type(SwigArrayWrapper) :: farg1 type(SwigClassWrapper) :: farg2 -logical(C_BOOL) :: farg3 -logical(C_BOOL) :: farg4 +integer(C_INT) :: farg3 +integer(C_INT) :: farg4 call SWIG_string_to_chararray(filename, farg1_chars, farg1) farg2 = pcomm%swigdata -farg3 = callfillcomplete -farg4 = tolerant +farg3 = SWIG_logical_to_int(callfillcomplete) +farg4 = SWIG_logical_to_int(tolerant) fresult = swigc_TpetraReader_readSparseGraphFile__SWIG_1(farg1, farg2, farg3, farg4) swig_result%swigdata = fresult end function @@ -11373,16 +11397,16 @@ function TpetraReader_readSparseGraphFile__SWIG_2(filename, pcomm, callfillcompl character(kind=C_CHAR), dimension(:), allocatable, target :: farg1_chars class(TeuchosComm), intent(in) :: pcomm -logical(C_BOOL), intent(in) :: callfillcomplete +logical, intent(in) :: callfillcomplete type(SwigClassWrapper) :: fresult type(SwigArrayWrapper) :: farg1 type(SwigClassWrapper) :: farg2 -logical(C_BOOL) :: farg3 +integer(C_INT) :: farg3 call SWIG_string_to_chararray(filename, farg1_chars, farg1) farg2 = pcomm%swigdata -farg3 = callfillcomplete +farg3 = SWIG_logical_to_int(callfillcomplete) fresult = swigc_TpetraReader_readSparseGraphFile__SWIG_2(farg1, farg2, farg3) swig_result%swigdata = fresult end function @@ -11417,23 +11441,23 @@ function TpetraReader_readSparseGraphFile__SWIG_4(filename, pcomm, constructorpa class(ParameterList), intent(in) :: fillcompleteparams -logical(C_BOOL), intent(in) :: tolerant -logical(C_BOOL), intent(in) :: debug +logical, intent(in) :: tolerant +logical, intent(in) :: debug type(SwigClassWrapper) :: fresult type(SwigArrayWrapper) :: farg1 type(SwigClassWrapper) :: farg2 type(SwigClassWrapper) :: farg3 type(SwigClassWrapper) :: farg4 -logical(C_BOOL) :: farg5 -logical(C_BOOL) :: farg6 +integer(C_INT) :: farg5 +integer(C_INT) :: farg6 call SWIG_string_to_chararray(filename, farg1_chars, farg1) farg2 = pcomm%swigdata farg3 = constructorparams%swigdata farg4 = fillcompleteparams%swigdata -farg5 = tolerant -farg6 = debug +farg5 = SWIG_logical_to_int(tolerant) +farg6 = SWIG_logical_to_int(debug) fresult = swigc_TpetraReader_readSparseGraphFile__SWIG_4(farg1, farg2, farg3, farg4, farg5, farg6) swig_result%swigdata = fresult end function @@ -11450,20 +11474,20 @@ function TpetraReader_readSparseGraphFile__SWIG_5(filename, pcomm, constructorpa class(ParameterList), intent(in) :: fillcompleteparams -logical(C_BOOL), intent(in) :: tolerant +logical, intent(in) :: tolerant type(SwigClassWrapper) :: fresult type(SwigArrayWrapper) :: farg1 type(SwigClassWrapper) :: farg2 type(SwigClassWrapper) :: farg3 type(SwigClassWrapper) :: farg4 -logical(C_BOOL) :: farg5 +integer(C_INT) :: farg5 call SWIG_string_to_chararray(filename, farg1_chars, farg1) farg2 = pcomm%swigdata farg3 = constructorparams%swigdata farg4 = fillcompleteparams%swigdata -farg5 = tolerant +farg5 = SWIG_logical_to_int(tolerant) fresult = swigc_TpetraReader_readSparseGraphFile__SWIG_5(farg1, farg2, farg3, farg4, farg5) swig_result%swigdata = fresult end function @@ -11509,9 +11533,9 @@ function TpetraReader_readSparseGraphFile__SWIG_7(filename, rowmap, colmap, doma class(TpetraMap), intent(in) :: rangemap -logical(C_BOOL), intent(in) :: callfillcomplete -logical(C_BOOL), intent(in) :: tolerant -logical(C_BOOL), intent(in) :: debug +logical, intent(in) :: callfillcomplete +logical, intent(in) :: tolerant +logical, intent(in) :: debug type(SwigClassWrapper) :: fresult type(SwigArrayWrapper) :: farg1 @@ -11519,18 +11543,18 @@ function TpetraReader_readSparseGraphFile__SWIG_7(filename, rowmap, colmap, doma type(SwigClassWrapper) :: farg3 type(SwigClassWrapper) :: farg4 type(SwigClassWrapper) :: farg5 -logical(C_BOOL) :: farg6 -logical(C_BOOL) :: farg7 -logical(C_BOOL) :: farg8 +integer(C_INT) :: farg6 +integer(C_INT) :: farg7 +integer(C_INT) :: farg8 call SWIG_string_to_chararray(filename, farg1_chars, farg1) farg2 = rowmap%swigdata farg3 = colmap%swigdata farg4 = domainmap%swigdata farg5 = rangemap%swigdata -farg6 = callfillcomplete -farg7 = tolerant -farg8 = debug +farg6 = SWIG_logical_to_int(callfillcomplete) +farg7 = SWIG_logical_to_int(tolerant) +farg8 = SWIG_logical_to_int(debug) fresult = swigc_TpetraReader_readSparseGraphFile__SWIG_7(farg1, farg2, farg3, farg4, farg5, farg6, farg7, farg8) swig_result%swigdata = fresult end function @@ -11549,8 +11573,8 @@ function TpetraReader_readSparseGraphFile__SWIG_8(filename, rowmap, colmap, doma class(TpetraMap), intent(in) :: rangemap -logical(C_BOOL), intent(in) :: callfillcomplete -logical(C_BOOL), intent(in) :: tolerant +logical, intent(in) :: callfillcomplete +logical, intent(in) :: tolerant type(SwigClassWrapper) :: fresult type(SwigArrayWrapper) :: farg1 @@ -11558,16 +11582,16 @@ function TpetraReader_readSparseGraphFile__SWIG_8(filename, rowmap, colmap, doma type(SwigClassWrapper) :: farg3 type(SwigClassWrapper) :: farg4 type(SwigClassWrapper) :: farg5 -logical(C_BOOL) :: farg6 -logical(C_BOOL) :: farg7 +integer(C_INT) :: farg6 +integer(C_INT) :: farg7 call SWIG_string_to_chararray(filename, farg1_chars, farg1) farg2 = rowmap%swigdata farg3 = colmap%swigdata farg4 = domainmap%swigdata farg5 = rangemap%swigdata -farg6 = callfillcomplete -farg7 = tolerant +farg6 = SWIG_logical_to_int(callfillcomplete) +farg7 = SWIG_logical_to_int(tolerant) fresult = swigc_TpetraReader_readSparseGraphFile__SWIG_8(farg1, farg2, farg3, farg4, farg5, farg6, farg7) swig_result%swigdata = fresult end function @@ -11586,7 +11610,7 @@ function TpetraReader_readSparseGraphFile__SWIG_9(filename, rowmap, colmap, doma class(TpetraMap), intent(in) :: rangemap -logical(C_BOOL), intent(in) :: callfillcomplete +logical, intent(in) :: callfillcomplete type(SwigClassWrapper) :: fresult type(SwigArrayWrapper) :: farg1 @@ -11594,14 +11618,14 @@ function TpetraReader_readSparseGraphFile__SWIG_9(filename, rowmap, colmap, doma type(SwigClassWrapper) :: farg3 type(SwigClassWrapper) :: farg4 type(SwigClassWrapper) :: farg5 -logical(C_BOOL) :: farg6 +integer(C_INT) :: farg6 call SWIG_string_to_chararray(filename, farg1_chars, farg1) farg2 = rowmap%swigdata farg3 = colmap%swigdata farg4 = domainmap%swigdata farg5 = rangemap%swigdata -farg6 = callfillcomplete +farg6 = SWIG_logical_to_int(callfillcomplete) fresult = swigc_TpetraReader_readSparseGraphFile__SWIG_9(farg1, farg2, farg3, farg4, farg5, farg6) swig_result%swigdata = fresult end function @@ -11644,22 +11668,22 @@ function TpetraReader_readSparseFile__SWIG_0(filename, pcomm, callfillcomplete, character(kind=C_CHAR), dimension(:), allocatable, target :: farg1_chars class(TeuchosComm), intent(in) :: pcomm -logical(C_BOOL), intent(in) :: callfillcomplete -logical(C_BOOL), intent(in) :: tolerant -logical(C_BOOL), intent(in) :: debug +logical, intent(in) :: callfillcomplete +logical, intent(in) :: tolerant +logical, intent(in) :: debug type(SwigClassWrapper) :: fresult type(SwigArrayWrapper) :: farg1 type(SwigClassWrapper) :: farg2 -logical(C_BOOL) :: farg3 -logical(C_BOOL) :: farg4 -logical(C_BOOL) :: farg5 +integer(C_INT) :: farg3 +integer(C_INT) :: farg4 +integer(C_INT) :: farg5 call SWIG_string_to_chararray(filename, farg1_chars, farg1) farg2 = pcomm%swigdata -farg3 = callfillcomplete -farg4 = tolerant -farg5 = debug +farg3 = SWIG_logical_to_int(callfillcomplete) +farg4 = SWIG_logical_to_int(tolerant) +farg5 = SWIG_logical_to_int(debug) fresult = swigc_TpetraReader_readSparseFile__SWIG_0(farg1, farg2, farg3, farg4, farg5) swig_result%swigdata = fresult end function @@ -11672,19 +11696,19 @@ function TpetraReader_readSparseFile__SWIG_1(filename, pcomm, callfillcomplete, character(kind=C_CHAR), dimension(:), allocatable, target :: farg1_chars class(TeuchosComm), intent(in) :: pcomm -logical(C_BOOL), intent(in) :: callfillcomplete -logical(C_BOOL), intent(in) :: tolerant +logical, intent(in) :: callfillcomplete +logical, intent(in) :: tolerant type(SwigClassWrapper) :: fresult type(SwigArrayWrapper) :: farg1 type(SwigClassWrapper) :: farg2 -logical(C_BOOL) :: farg3 -logical(C_BOOL) :: farg4 +integer(C_INT) :: farg3 +integer(C_INT) :: farg4 call SWIG_string_to_chararray(filename, farg1_chars, farg1) farg2 = pcomm%swigdata -farg3 = callfillcomplete -farg4 = tolerant +farg3 = SWIG_logical_to_int(callfillcomplete) +farg4 = SWIG_logical_to_int(tolerant) fresult = swigc_TpetraReader_readSparseFile__SWIG_1(farg1, farg2, farg3, farg4) swig_result%swigdata = fresult end function @@ -11697,16 +11721,16 @@ function TpetraReader_readSparseFile__SWIG_2(filename, pcomm, callfillcomplete) character(kind=C_CHAR), dimension(:), allocatable, target :: farg1_chars class(TeuchosComm), intent(in) :: pcomm -logical(C_BOOL), intent(in) :: callfillcomplete +logical, intent(in) :: callfillcomplete type(SwigClassWrapper) :: fresult type(SwigArrayWrapper) :: farg1 type(SwigClassWrapper) :: farg2 -logical(C_BOOL) :: farg3 +integer(C_INT) :: farg3 call SWIG_string_to_chararray(filename, farg1_chars, farg1) farg2 = pcomm%swigdata -farg3 = callfillcomplete +farg3 = SWIG_logical_to_int(callfillcomplete) fresult = swigc_TpetraReader_readSparseFile__SWIG_2(farg1, farg2, farg3) swig_result%swigdata = fresult end function @@ -11741,23 +11765,23 @@ function TpetraReader_readSparseFile__SWIG_4(filename, pcomm, constructorparams, class(ParameterList), intent(in) :: fillcompleteparams -logical(C_BOOL), intent(in) :: tolerant -logical(C_BOOL), intent(in) :: debug +logical, intent(in) :: tolerant +logical, intent(in) :: debug type(SwigClassWrapper) :: fresult type(SwigArrayWrapper) :: farg1 type(SwigClassWrapper) :: farg2 type(SwigClassWrapper) :: farg3 type(SwigClassWrapper) :: farg4 -logical(C_BOOL) :: farg5 -logical(C_BOOL) :: farg6 +integer(C_INT) :: farg5 +integer(C_INT) :: farg6 call SWIG_string_to_chararray(filename, farg1_chars, farg1) farg2 = pcomm%swigdata farg3 = constructorparams%swigdata farg4 = fillcompleteparams%swigdata -farg5 = tolerant -farg6 = debug +farg5 = SWIG_logical_to_int(tolerant) +farg6 = SWIG_logical_to_int(debug) fresult = swigc_TpetraReader_readSparseFile__SWIG_4(farg1, farg2, farg3, farg4, farg5, farg6) swig_result%swigdata = fresult end function @@ -11774,20 +11798,20 @@ function TpetraReader_readSparseFile__SWIG_5(filename, pcomm, constructorparams, class(ParameterList), intent(in) :: fillcompleteparams -logical(C_BOOL), intent(in) :: tolerant +logical, intent(in) :: tolerant type(SwigClassWrapper) :: fresult type(SwigArrayWrapper) :: farg1 type(SwigClassWrapper) :: farg2 type(SwigClassWrapper) :: farg3 type(SwigClassWrapper) :: farg4 -logical(C_BOOL) :: farg5 +integer(C_INT) :: farg5 call SWIG_string_to_chararray(filename, farg1_chars, farg1) farg2 = pcomm%swigdata farg3 = constructorparams%swigdata farg4 = fillcompleteparams%swigdata -farg5 = tolerant +farg5 = SWIG_logical_to_int(tolerant) fresult = swigc_TpetraReader_readSparseFile__SWIG_5(farg1, farg2, farg3, farg4, farg5) swig_result%swigdata = fresult end function @@ -11832,9 +11856,9 @@ function TpetraReader_readSparseFile__SWIG_7(filename, rowmap, colmap, domainmap class(TpetraMap), intent(in) :: rangemap -logical(C_BOOL), intent(in) :: callfillcomplete -logical(C_BOOL), intent(in) :: tolerant -logical(C_BOOL), intent(in) :: debug +logical, intent(in) :: callfillcomplete +logical, intent(in) :: tolerant +logical, intent(in) :: debug type(SwigClassWrapper) :: fresult type(SwigArrayWrapper) :: farg1 @@ -11842,18 +11866,18 @@ function TpetraReader_readSparseFile__SWIG_7(filename, rowmap, colmap, domainmap type(SwigClassWrapper) :: farg3 type(SwigClassWrapper) :: farg4 type(SwigClassWrapper) :: farg5 -logical(C_BOOL) :: farg6 -logical(C_BOOL) :: farg7 -logical(C_BOOL) :: farg8 +integer(C_INT) :: farg6 +integer(C_INT) :: farg7 +integer(C_INT) :: farg8 call SWIG_string_to_chararray(filename, farg1_chars, farg1) farg2 = rowmap%swigdata farg3 = colmap%swigdata farg4 = domainmap%swigdata farg5 = rangemap%swigdata -farg6 = callfillcomplete -farg7 = tolerant -farg8 = debug +farg6 = SWIG_logical_to_int(callfillcomplete) +farg7 = SWIG_logical_to_int(tolerant) +farg8 = SWIG_logical_to_int(debug) fresult = swigc_TpetraReader_readSparseFile__SWIG_7(farg1, farg2, farg3, farg4, farg5, farg6, farg7, farg8) swig_result%swigdata = fresult end function @@ -11872,8 +11896,8 @@ function TpetraReader_readSparseFile__SWIG_8(filename, rowmap, colmap, domainmap class(TpetraMap), intent(in) :: rangemap -logical(C_BOOL), intent(in) :: callfillcomplete -logical(C_BOOL), intent(in) :: tolerant +logical, intent(in) :: callfillcomplete +logical, intent(in) :: tolerant type(SwigClassWrapper) :: fresult type(SwigArrayWrapper) :: farg1 @@ -11881,16 +11905,16 @@ function TpetraReader_readSparseFile__SWIG_8(filename, rowmap, colmap, domainmap type(SwigClassWrapper) :: farg3 type(SwigClassWrapper) :: farg4 type(SwigClassWrapper) :: farg5 -logical(C_BOOL) :: farg6 -logical(C_BOOL) :: farg7 +integer(C_INT) :: farg6 +integer(C_INT) :: farg7 call SWIG_string_to_chararray(filename, farg1_chars, farg1) farg2 = rowmap%swigdata farg3 = colmap%swigdata farg4 = domainmap%swigdata farg5 = rangemap%swigdata -farg6 = callfillcomplete -farg7 = tolerant +farg6 = SWIG_logical_to_int(callfillcomplete) +farg7 = SWIG_logical_to_int(tolerant) fresult = swigc_TpetraReader_readSparseFile__SWIG_8(farg1, farg2, farg3, farg4, farg5, farg6, farg7) swig_result%swigdata = fresult end function @@ -11909,7 +11933,7 @@ function TpetraReader_readSparseFile__SWIG_9(filename, rowmap, colmap, domainmap class(TpetraMap), intent(in) :: rangemap -logical(C_BOOL), intent(in) :: callfillcomplete +logical, intent(in) :: callfillcomplete type(SwigClassWrapper) :: fresult type(SwigArrayWrapper) :: farg1 @@ -11917,14 +11941,14 @@ function TpetraReader_readSparseFile__SWIG_9(filename, rowmap, colmap, domainmap type(SwigClassWrapper) :: farg3 type(SwigClassWrapper) :: farg4 type(SwigClassWrapper) :: farg5 -logical(C_BOOL) :: farg6 +integer(C_INT) :: farg6 call SWIG_string_to_chararray(filename, farg1_chars, farg1) farg2 = rowmap%swigdata farg3 = colmap%swigdata farg4 = domainmap%swigdata farg5 = rangemap%swigdata -farg6 = callfillcomplete +farg6 = SWIG_logical_to_int(callfillcomplete) fresult = swigc_TpetraReader_readSparseFile__SWIG_9(farg1, farg2, farg3, farg4, farg5, farg6) swig_result%swigdata = fresult end function @@ -11969,21 +11993,21 @@ function TpetraReader_readDenseFile__SWIG_0(filename, comm, map, tolerant, debug class(TpetraMap), intent(inout) :: map -logical(C_BOOL), intent(in) :: tolerant -logical(C_BOOL), intent(in) :: debug +logical, intent(in) :: tolerant +logical, intent(in) :: debug type(SwigClassWrapper) :: fresult type(SwigArrayWrapper) :: farg1 type(SwigClassWrapper) :: farg2 type(SwigClassWrapper) :: farg3 -logical(C_BOOL) :: farg4 -logical(C_BOOL) :: farg5 +integer(C_INT) :: farg4 +integer(C_INT) :: farg5 call SWIG_string_to_chararray(filename, farg1_chars, farg1) farg2 = comm%swigdata farg3 = map%swigdata -farg4 = tolerant -farg5 = debug +farg4 = SWIG_logical_to_int(tolerant) +farg5 = SWIG_logical_to_int(debug) fresult = swigc_TpetraReader_readDenseFile__SWIG_0(farg1, farg2, farg3, farg4, farg5) swig_result%swigdata = fresult end function @@ -11998,18 +12022,18 @@ function TpetraReader_readDenseFile__SWIG_1(filename, comm, map, tolerant) & class(TpetraMap), intent(inout) :: map -logical(C_BOOL), intent(in) :: tolerant +logical, intent(in) :: tolerant type(SwigClassWrapper) :: fresult type(SwigArrayWrapper) :: farg1 type(SwigClassWrapper) :: farg2 type(SwigClassWrapper) :: farg3 -logical(C_BOOL) :: farg4 +integer(C_INT) :: farg4 call SWIG_string_to_chararray(filename, farg1_chars, farg1) farg2 = comm%swigdata farg3 = map%swigdata -farg4 = tolerant +farg4 = SWIG_logical_to_int(tolerant) fresult = swigc_TpetraReader_readDenseFile__SWIG_1(farg1, farg2, farg3, farg4) swig_result%swigdata = fresult end function @@ -12044,19 +12068,19 @@ function TpetraReader_readMapFile__SWIG_0(filename, comm, tolerant, debug) & character(kind=C_CHAR), dimension(:), allocatable, target :: farg1_chars class(TeuchosComm), intent(in) :: comm -logical(C_BOOL), intent(in) :: tolerant -logical(C_BOOL), intent(in) :: debug +logical, intent(in) :: tolerant +logical, intent(in) :: debug type(SwigClassWrapper) :: fresult type(SwigArrayWrapper) :: farg1 type(SwigClassWrapper) :: farg2 -logical(C_BOOL) :: farg3 -logical(C_BOOL) :: farg4 +integer(C_INT) :: farg3 +integer(C_INT) :: farg4 call SWIG_string_to_chararray(filename, farg1_chars, farg1) farg2 = comm%swigdata -farg3 = tolerant -farg4 = debug +farg3 = SWIG_logical_to_int(tolerant) +farg4 = SWIG_logical_to_int(debug) fresult = swigc_TpetraReader_readMapFile__SWIG_0(farg1, farg2, farg3, farg4) swig_result%swigdata = fresult end function @@ -12069,16 +12093,16 @@ function TpetraReader_readMapFile__SWIG_1(filename, comm, tolerant) & character(kind=C_CHAR), dimension(:), allocatable, target :: farg1_chars class(TeuchosComm), intent(in) :: comm -logical(C_BOOL), intent(in) :: tolerant +logical, intent(in) :: tolerant type(SwigClassWrapper) :: fresult type(SwigArrayWrapper) :: farg1 type(SwigClassWrapper) :: farg2 -logical(C_BOOL) :: farg3 +integer(C_INT) :: farg3 call SWIG_string_to_chararray(filename, farg1_chars, farg1) farg2 = comm%swigdata -farg3 = tolerant +farg3 = SWIG_logical_to_int(tolerant) fresult = swigc_TpetraReader_readMapFile__SWIG_1(farg1, farg2, farg3) swig_result%swigdata = fresult end function @@ -12156,19 +12180,19 @@ subroutine TpetraWriter_writeSparseFile__SWIG_0(filename, pmatrix, matrixname, m character(kind=C_CHAR), dimension(:), allocatable, target :: farg3_chars character(kind=C_CHAR, len=*), target :: matrixdescription character(kind=C_CHAR), dimension(:), allocatable, target :: farg4_chars -logical(C_BOOL), intent(in) :: debug +logical, intent(in) :: debug type(SwigArrayWrapper) :: farg1 type(SwigClassWrapper) :: farg2 type(SwigArrayWrapper) :: farg3 type(SwigArrayWrapper) :: farg4 -logical(C_BOOL) :: farg5 +integer(C_INT) :: farg5 call SWIG_string_to_chararray(filename, farg1_chars, farg1) farg2 = pmatrix%swigdata call SWIG_string_to_chararray(matrixname, farg3_chars, farg3) call SWIG_string_to_chararray(matrixdescription, farg4_chars, farg4) -farg5 = debug +farg5 = SWIG_logical_to_int(debug) call swigc_TpetraWriter_writeSparseFile__SWIG_0(farg1, farg2, farg3, farg4, farg5) end subroutine @@ -12201,15 +12225,15 @@ subroutine TpetraWriter_writeSparseFile__SWIG_2(filename, pmatrix, debug) character(kind=C_CHAR), dimension(:), allocatable, target :: farg1_chars class(TpetraCrsMatrix), intent(in) :: pmatrix -logical(C_BOOL), intent(in) :: debug +logical, intent(in) :: debug type(SwigArrayWrapper) :: farg1 type(SwigClassWrapper) :: farg2 -logical(C_BOOL) :: farg3 +integer(C_INT) :: farg3 call SWIG_string_to_chararray(filename, farg1_chars, farg1) farg2 = pmatrix%swigdata -farg3 = debug +farg3 = SWIG_logical_to_int(debug) call swigc_TpetraWriter_writeSparseFile__SWIG_2(farg1, farg2, farg3) end subroutine @@ -12237,19 +12261,19 @@ subroutine TpetraWriter_writeSparseGraphFile__SWIG_0(filename, pgraph, graphname character(kind=C_CHAR), dimension(:), allocatable, target :: farg3_chars character(kind=C_CHAR, len=*), target :: graphdescription character(kind=C_CHAR), dimension(:), allocatable, target :: farg4_chars -logical(C_BOOL), intent(in) :: debug +logical, intent(in) :: debug type(SwigArrayWrapper) :: farg1 type(SwigClassWrapper) :: farg2 type(SwigArrayWrapper) :: farg3 type(SwigArrayWrapper) :: farg4 -logical(C_BOOL) :: farg5 +integer(C_INT) :: farg5 call SWIG_string_to_chararray(filename, farg1_chars, farg1) farg2 = pgraph%swigdata call SWIG_string_to_chararray(graphname, farg3_chars, farg3) call SWIG_string_to_chararray(graphdescription, farg4_chars, farg4) -farg5 = debug +farg5 = SWIG_logical_to_int(debug) call swigc_TpetraWriter_writeSparseGraphFile__SWIG_0(farg1, farg2, farg3, farg4, farg5) end subroutine @@ -12282,15 +12306,15 @@ subroutine TpetraWriter_writeSparseGraphFile__SWIG_2(filename, pgraph, debug) character(kind=C_CHAR), dimension(:), allocatable, target :: farg1_chars class(TpetraCrsGraph), intent(in) :: pgraph -logical(C_BOOL), intent(in) :: debug +logical, intent(in) :: debug type(SwigArrayWrapper) :: farg1 type(SwigClassWrapper) :: farg2 -logical(C_BOOL) :: farg3 +integer(C_INT) :: farg3 call SWIG_string_to_chararray(filename, farg1_chars, farg1) farg2 = pgraph%swigdata -farg3 = debug +farg3 = SWIG_logical_to_int(debug) call swigc_TpetraWriter_writeSparseGraphFile__SWIG_2(farg1, farg2, farg3) end subroutine @@ -12380,32 +12404,32 @@ subroutine TpetraMatrixMatrixMultiply__SWIG_0(a, transposea, b, transposeb, c, c use, intrinsic :: ISO_C_BINDING class(TpetraCrsMatrix), intent(in) :: a -logical(C_BOOL), intent(in) :: transposea +logical, intent(in) :: transposea class(TpetraCrsMatrix), intent(in) :: b -logical(C_BOOL), intent(in) :: transposeb +logical, intent(in) :: transposeb class(TpetraCrsMatrix), intent(inout) :: c -logical(C_BOOL), intent(in) :: call_fillcomplete_on_result +logical, intent(in) :: call_fillcomplete_on_result character(kind=C_CHAR, len=*), target :: label character(kind=C_CHAR), dimension(:), allocatable, target :: farg7_chars class(ParameterList), intent(in) :: params type(SwigClassWrapper) :: farg1 -logical(C_BOOL) :: farg2 +integer(C_INT) :: farg2 type(SwigClassWrapper) :: farg3 -logical(C_BOOL) :: farg4 +integer(C_INT) :: farg4 type(SwigClassWrapper) :: farg5 -logical(C_BOOL) :: farg6 +integer(C_INT) :: farg6 type(SwigArrayWrapper) :: farg7 type(SwigClassWrapper) :: farg8 farg1 = a%swigdata -farg2 = transposea +farg2 = SWIG_logical_to_int(transposea) farg3 = b%swigdata -farg4 = transposeb +farg4 = SWIG_logical_to_int(transposeb) farg5 = c%swigdata -farg6 = call_fillcomplete_on_result +farg6 = SWIG_logical_to_int(call_fillcomplete_on_result) call SWIG_string_to_chararray(label, farg7_chars, farg7) farg8 = params%swigdata call swigc_TpetraMatrixMatrixMultiply__SWIG_0(farg1, farg2, farg3, farg4, farg5, farg6, farg7, farg8) @@ -12415,30 +12439,30 @@ subroutine TpetraMatrixMatrixMultiply__SWIG_1(a, transposea, b, transposeb, c, c use, intrinsic :: ISO_C_BINDING class(TpetraCrsMatrix), intent(in) :: a -logical(C_BOOL), intent(in) :: transposea +logical, intent(in) :: transposea class(TpetraCrsMatrix), intent(in) :: b -logical(C_BOOL), intent(in) :: transposeb +logical, intent(in) :: transposeb class(TpetraCrsMatrix), intent(inout) :: c -logical(C_BOOL), intent(in) :: call_fillcomplete_on_result +logical, intent(in) :: call_fillcomplete_on_result character(kind=C_CHAR, len=*), target :: label character(kind=C_CHAR), dimension(:), allocatable, target :: farg7_chars type(SwigClassWrapper) :: farg1 -logical(C_BOOL) :: farg2 +integer(C_INT) :: farg2 type(SwigClassWrapper) :: farg3 -logical(C_BOOL) :: farg4 +integer(C_INT) :: farg4 type(SwigClassWrapper) :: farg5 -logical(C_BOOL) :: farg6 +integer(C_INT) :: farg6 type(SwigArrayWrapper) :: farg7 farg1 = a%swigdata -farg2 = transposea +farg2 = SWIG_logical_to_int(transposea) farg3 = b%swigdata -farg4 = transposeb +farg4 = SWIG_logical_to_int(transposeb) farg5 = c%swigdata -farg6 = call_fillcomplete_on_result +farg6 = SWIG_logical_to_int(call_fillcomplete_on_result) call SWIG_string_to_chararray(label, farg7_chars, farg7) call swigc_TpetraMatrixMatrixMultiply__SWIG_1(farg1, farg2, farg3, farg4, farg5, farg6, farg7) end subroutine @@ -12447,27 +12471,27 @@ subroutine TpetraMatrixMatrixMultiply__SWIG_2(a, transposea, b, transposeb, c, c use, intrinsic :: ISO_C_BINDING class(TpetraCrsMatrix), intent(in) :: a -logical(C_BOOL), intent(in) :: transposea +logical, intent(in) :: transposea class(TpetraCrsMatrix), intent(in) :: b -logical(C_BOOL), intent(in) :: transposeb +logical, intent(in) :: transposeb class(TpetraCrsMatrix), intent(inout) :: c -logical(C_BOOL), intent(in) :: call_fillcomplete_on_result +logical, intent(in) :: call_fillcomplete_on_result type(SwigClassWrapper) :: farg1 -logical(C_BOOL) :: farg2 +integer(C_INT) :: farg2 type(SwigClassWrapper) :: farg3 -logical(C_BOOL) :: farg4 +integer(C_INT) :: farg4 type(SwigClassWrapper) :: farg5 -logical(C_BOOL) :: farg6 +integer(C_INT) :: farg6 farg1 = a%swigdata -farg2 = transposea +farg2 = SWIG_logical_to_int(transposea) farg3 = b%swigdata -farg4 = transposeb +farg4 = SWIG_logical_to_int(transposeb) farg5 = c%swigdata -farg6 = call_fillcomplete_on_result +farg6 = SWIG_logical_to_int(call_fillcomplete_on_result) call swigc_TpetraMatrixMatrixMultiply__SWIG_2(farg1, farg2, farg3, farg4, farg5, farg6) end subroutine @@ -12475,22 +12499,22 @@ subroutine TpetraMatrixMatrixMultiply__SWIG_3(a, transposea, b, transposeb, c) use, intrinsic :: ISO_C_BINDING class(TpetraCrsMatrix), intent(in) :: a -logical(C_BOOL), intent(in) :: transposea +logical, intent(in) :: transposea class(TpetraCrsMatrix), intent(in) :: b -logical(C_BOOL), intent(in) :: transposeb +logical, intent(in) :: transposeb class(TpetraCrsMatrix), intent(inout) :: c type(SwigClassWrapper) :: farg1 -logical(C_BOOL) :: farg2 +integer(C_INT) :: farg2 type(SwigClassWrapper) :: farg3 -logical(C_BOOL) :: farg4 +integer(C_INT) :: farg4 type(SwigClassWrapper) :: farg5 farg1 = a%swigdata -farg2 = transposea +farg2 = SWIG_logical_to_int(transposea) farg3 = b%swigdata -farg4 = transposeb +farg4 = SWIG_logical_to_int(transposeb) farg5 = c%swigdata call swigc_TpetraMatrixMatrixMultiply__SWIG_3(farg1, farg2, farg3, farg4, farg5) end subroutine @@ -12499,20 +12523,20 @@ subroutine TpetraMatrixMatrixAdd__SWIG_0(a, transposea, scalara, b, scalarb) use, intrinsic :: ISO_C_BINDING class(TpetraCrsMatrix), intent(in) :: a -logical(C_BOOL), intent(in) :: transposea +logical, intent(in) :: transposea real(C_DOUBLE), intent(in) :: scalara class(TpetraCrsMatrix), intent(inout) :: b real(C_DOUBLE), intent(in) :: scalarb type(SwigClassWrapper) :: farg1 -logical(C_BOOL) :: farg2 +integer(C_INT) :: farg2 real(C_DOUBLE) :: farg3 type(SwigClassWrapper) :: farg4 real(C_DOUBLE) :: farg5 farg1 = a%swigdata -farg2 = transposea +farg2 = SWIG_logical_to_int(transposea) farg3 = scalara farg4 = b%swigdata farg5 = scalarb @@ -12523,27 +12547,27 @@ subroutine TpetraMatrixMatrixAdd__SWIG_1(a, transposea, scalara, b, transposeb, use, intrinsic :: ISO_C_BINDING class(TpetraCrsMatrix), intent(in) :: a -logical(C_BOOL), intent(in) :: transposea +logical, intent(in) :: transposea real(C_DOUBLE), intent(in) :: scalara class(TpetraCrsMatrix), intent(in) :: b -logical(C_BOOL), intent(in) :: transposeb +logical, intent(in) :: transposeb real(C_DOUBLE), intent(in) :: scalarb class(TpetraCrsMatrix), intent(inout) :: c type(SwigClassWrapper) :: farg1 -logical(C_BOOL) :: farg2 +integer(C_INT) :: farg2 real(C_DOUBLE) :: farg3 type(SwigClassWrapper) :: farg4 -logical(C_BOOL) :: farg5 +integer(C_INT) :: farg5 real(C_DOUBLE) :: farg6 type(SwigClassWrapper) :: farg7 farg1 = a%swigdata -farg2 = transposea +farg2 = SWIG_logical_to_int(transposea) farg3 = scalara farg4 = b%swigdata -farg5 = transposeb +farg5 = SWIG_logical_to_int(transposeb) farg6 = scalarb farg7 = c%swigdata call swigc_TpetraMatrixMatrixAdd__SWIG_1(farg1, farg2, farg3, farg4, farg5, farg6, farg7) diff --git a/src/tpetra/src/swig/fortpetraFORTRAN_wrap.cxx b/src/tpetra/src/swig/fortpetraFORTRAN_wrap.cxx index b88a5aef..9ad90075 100644 --- a/src/tpetra/src/swig/fortpetraFORTRAN_wrap.cxx +++ b/src/tpetra/src/swig/fortpetraFORTRAN_wrap.cxx @@ -1222,8 +1222,8 @@ SWIGEXPORT void _wrap_delete_TpetraMap(SwigClassWrapper const *farg1) { } -SWIGEXPORT bool _wrap_TpetraMap_isOneToOne(SwigClassWrapper const *farg1) { - bool fresult ; +SWIGEXPORT int _wrap_TpetraMap_isOneToOne(SwigClassWrapper const *farg1) { + int fresult ; Tpetra::Map< LO,GO,NO > *arg1 = (Tpetra::Map< LO,GO,NO > *) 0 ; Teuchos::RCP< Tpetra::Map< LO,GO,NO > const > *smartarg1 ; bool result; @@ -1253,7 +1253,7 @@ SWIGEXPORT bool _wrap_TpetraMap_isOneToOne(SwigClassWrapper const *farg1) { SWIG_exception_impl("Tpetra::Map< LO,GO,NO >::isOneToOne() const", SWIG_UnknownError, "An unknown exception occurred", return 0); } } - fresult = static_cast< bool >(result); + fresult = (result ? 1 : 0); return fresult; } @@ -1622,8 +1622,8 @@ SWIGEXPORT long long _wrap_TpetraMap_getGlobalElement(SwigClassWrapper const *fa } -SWIGEXPORT bool _wrap_TpetraMap_isNodeLocalElement(SwigClassWrapper const *farg1, int const *farg2) { - bool fresult ; +SWIGEXPORT int _wrap_TpetraMap_isNodeLocalElement(SwigClassWrapper const *farg1, int const *farg2) { + int fresult ; Tpetra::Map< LO,GO,NO > *arg1 = (Tpetra::Map< LO,GO,NO > *) 0 ; int arg2 ; Teuchos::RCP< Tpetra::Map< LO,GO,NO > const > *smartarg1 ; @@ -1655,13 +1655,13 @@ SWIGEXPORT bool _wrap_TpetraMap_isNodeLocalElement(SwigClassWrapper const *farg1 SWIG_exception_impl("Tpetra::Map< LO,GO,NO >::isNodeLocalElement(int) const", SWIG_UnknownError, "An unknown exception occurred", return 0); } } - fresult = static_cast< bool >(result); + fresult = (result ? 1 : 0); return fresult; } -SWIGEXPORT bool _wrap_TpetraMap_isNodeGlobalElement(SwigClassWrapper const *farg1, long long const *farg2) { - bool fresult ; +SWIGEXPORT int _wrap_TpetraMap_isNodeGlobalElement(SwigClassWrapper const *farg1, long long const *farg2) { + int fresult ; Tpetra::Map< LO,GO,NO > *arg1 = (Tpetra::Map< LO,GO,NO > *) 0 ; long long arg2 ; Teuchos::RCP< Tpetra::Map< LO,GO,NO > const > *smartarg1 ; @@ -1693,13 +1693,13 @@ SWIGEXPORT bool _wrap_TpetraMap_isNodeGlobalElement(SwigClassWrapper const *farg SWIG_exception_impl("Tpetra::Map< LO,GO,NO >::isNodeGlobalElement(long long) const", SWIG_UnknownError, "An unknown exception occurred", return 0); } } - fresult = static_cast< bool >(result); + fresult = (result ? 1 : 0); return fresult; } -SWIGEXPORT bool _wrap_TpetraMap_isUniform(SwigClassWrapper const *farg1) { - bool fresult ; +SWIGEXPORT int _wrap_TpetraMap_isUniform(SwigClassWrapper const *farg1) { + int fresult ; Tpetra::Map< LO,GO,NO > *arg1 = (Tpetra::Map< LO,GO,NO > *) 0 ; Teuchos::RCP< Tpetra::Map< LO,GO,NO > const > *smartarg1 ; bool result; @@ -1729,13 +1729,13 @@ SWIGEXPORT bool _wrap_TpetraMap_isUniform(SwigClassWrapper const *farg1) { SWIG_exception_impl("Tpetra::Map< LO,GO,NO >::isUniform() const", SWIG_UnknownError, "An unknown exception occurred", return 0); } } - fresult = static_cast< bool >(result); + fresult = (result ? 1 : 0); return fresult; } -SWIGEXPORT bool _wrap_TpetraMap_isContiguous(SwigClassWrapper const *farg1) { - bool fresult ; +SWIGEXPORT int _wrap_TpetraMap_isContiguous(SwigClassWrapper const *farg1) { + int fresult ; Tpetra::Map< LO,GO,NO > *arg1 = (Tpetra::Map< LO,GO,NO > *) 0 ; Teuchos::RCP< Tpetra::Map< LO,GO,NO > const > *smartarg1 ; bool result; @@ -1765,13 +1765,13 @@ SWIGEXPORT bool _wrap_TpetraMap_isContiguous(SwigClassWrapper const *farg1) { SWIG_exception_impl("Tpetra::Map< LO,GO,NO >::isContiguous() const", SWIG_UnknownError, "An unknown exception occurred", return 0); } } - fresult = static_cast< bool >(result); + fresult = (result ? 1 : 0); return fresult; } -SWIGEXPORT bool _wrap_TpetraMap_isDistributed(SwigClassWrapper const *farg1) { - bool fresult ; +SWIGEXPORT int _wrap_TpetraMap_isDistributed(SwigClassWrapper const *farg1) { + int fresult ; Tpetra::Map< LO,GO,NO > *arg1 = (Tpetra::Map< LO,GO,NO > *) 0 ; Teuchos::RCP< Tpetra::Map< LO,GO,NO > const > *smartarg1 ; bool result; @@ -1801,13 +1801,13 @@ SWIGEXPORT bool _wrap_TpetraMap_isDistributed(SwigClassWrapper const *farg1) { SWIG_exception_impl("Tpetra::Map< LO,GO,NO >::isDistributed() const", SWIG_UnknownError, "An unknown exception occurred", return 0); } } - fresult = static_cast< bool >(result); + fresult = (result ? 1 : 0); return fresult; } -SWIGEXPORT bool _wrap_TpetraMap_isCompatible(SwigClassWrapper const *farg1, SwigClassWrapper const *farg2) { - bool fresult ; +SWIGEXPORT int _wrap_TpetraMap_isCompatible(SwigClassWrapper const *farg1, SwigClassWrapper const *farg2) { + int fresult ; Tpetra::Map< LO,GO,NO > *arg1 = (Tpetra::Map< LO,GO,NO > *) 0 ; Tpetra::Map< int,long long,Kokkos::Compat::KokkosSerialWrapperNode > *arg2 = 0 ; Teuchos::RCP< Tpetra::Map< LO,GO,NO > const > *smartarg1 ; @@ -1842,13 +1842,13 @@ SWIGEXPORT bool _wrap_TpetraMap_isCompatible(SwigClassWrapper const *farg1, Swig SWIG_exception_impl("Tpetra::Map< LO,GO,NO >::isCompatible(Tpetra::Map< int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &) const", SWIG_UnknownError, "An unknown exception occurred", return 0); } } - fresult = static_cast< bool >(result); + fresult = (result ? 1 : 0); return fresult; } -SWIGEXPORT bool _wrap_TpetraMap_isSameAs(SwigClassWrapper const *farg1, SwigClassWrapper const *farg2) { - bool fresult ; +SWIGEXPORT int _wrap_TpetraMap_isSameAs(SwigClassWrapper const *farg1, SwigClassWrapper const *farg2) { + int fresult ; Tpetra::Map< LO,GO,NO > *arg1 = (Tpetra::Map< LO,GO,NO > *) 0 ; Tpetra::Map< int,long long,Kokkos::Compat::KokkosSerialWrapperNode > *arg2 = 0 ; Teuchos::RCP< Tpetra::Map< LO,GO,NO > const > *smartarg1 ; @@ -1883,13 +1883,13 @@ SWIGEXPORT bool _wrap_TpetraMap_isSameAs(SwigClassWrapper const *farg1, SwigClas SWIG_exception_impl("Tpetra::Map< LO,GO,NO >::isSameAs(Tpetra::Map< int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &) const", SWIG_UnknownError, "An unknown exception occurred", return 0); } } - fresult = static_cast< bool >(result); + fresult = (result ? 1 : 0); return fresult; } -SWIGEXPORT bool _wrap_TpetraMap_locallySameAs(SwigClassWrapper const *farg1, SwigClassWrapper const *farg2) { - bool fresult ; +SWIGEXPORT int _wrap_TpetraMap_locallySameAs(SwigClassWrapper const *farg1, SwigClassWrapper const *farg2) { + int fresult ; Tpetra::Map< LO,GO,NO > *arg1 = (Tpetra::Map< LO,GO,NO > *) 0 ; Tpetra::Map< int,long long,Tpetra::Map< LO,GO,NO >::node_type > *arg2 = 0 ; Teuchos::RCP< Tpetra::Map< LO,GO,NO > const > *smartarg1 ; @@ -1924,13 +1924,13 @@ SWIGEXPORT bool _wrap_TpetraMap_locallySameAs(SwigClassWrapper const *farg1, Swi SWIG_exception_impl("Tpetra::Map< LO,GO,NO >::locallySameAs(Tpetra::Map< int,long long,Tpetra::Map< LO,GO,NO >::node_type > const &) const", SWIG_UnknownError, "An unknown exception occurred", return 0); } } - fresult = static_cast< bool >(result); + fresult = (result ? 1 : 0); return fresult; } -SWIGEXPORT bool _wrap_TpetraMap_isLocallyFitted(SwigClassWrapper const *farg1, SwigClassWrapper const *farg2) { - bool fresult ; +SWIGEXPORT int _wrap_TpetraMap_isLocallyFitted(SwigClassWrapper const *farg1, SwigClassWrapper const *farg2) { + int fresult ; Tpetra::Map< LO,GO,NO > *arg1 = (Tpetra::Map< LO,GO,NO > *) 0 ; Tpetra::Map< int,long long,Kokkos::Compat::KokkosSerialWrapperNode > *arg2 = 0 ; Teuchos::RCP< Tpetra::Map< LO,GO,NO > const > *smartarg1 ; @@ -1965,7 +1965,7 @@ SWIGEXPORT bool _wrap_TpetraMap_isLocallyFitted(SwigClassWrapper const *farg1, S SWIG_exception_impl("Tpetra::Map< LO,GO,NO >::isLocallyFitted(Tpetra::Map< int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &) const", SWIG_UnknownError, "An unknown exception occurred", return 0); } } - fresult = static_cast< bool >(result); + fresult = (result ? 1 : 0); return fresult; } @@ -2859,8 +2859,8 @@ SWIGEXPORT SwigClassWrapper _wrap_TpetraExport_getTargetMap(SwigClassWrapper con } -SWIGEXPORT bool _wrap_TpetraExport_isLocallyComplete(SwigClassWrapper const *farg1) { - bool fresult ; +SWIGEXPORT int _wrap_TpetraExport_isLocallyComplete(SwigClassWrapper const *farg1) { + int fresult ; Tpetra::Export< LO,GO,NO > *arg1 = (Tpetra::Export< LO,GO,NO > *) 0 ; Teuchos::RCP< Tpetra::Export< LO,GO,NO > const > *smartarg1 ; bool result; @@ -2890,7 +2890,7 @@ SWIGEXPORT bool _wrap_TpetraExport_isLocallyComplete(SwigClassWrapper const *far SWIG_exception_impl("Tpetra::Export< LO,GO,NO >::isLocallyComplete() const", SWIG_UnknownError, "An unknown exception occurred", return 0); } } - fresult = static_cast< bool >(result); + fresult = (result ? 1 : 0); return fresult; } @@ -3347,8 +3347,8 @@ SWIGEXPORT SwigClassWrapper _wrap_TpetraImport_getTargetMap(SwigClassWrapper con } -SWIGEXPORT bool _wrap_TpetraImport_isLocallyComplete(SwigClassWrapper const *farg1) { - bool fresult ; +SWIGEXPORT int _wrap_TpetraImport_isLocallyComplete(SwigClassWrapper const *farg1) { + int fresult ; Tpetra::Import< LO,GO,NO > *arg1 = (Tpetra::Import< LO,GO,NO > *) 0 ; Teuchos::RCP< Tpetra::Import< LO,GO,NO > const > *smartarg1 ; bool result; @@ -3378,7 +3378,7 @@ SWIGEXPORT bool _wrap_TpetraImport_isLocallyComplete(SwigClassWrapper const *far SWIG_exception_impl("Tpetra::Import< LO,GO,NO >::isLocallyComplete() const", SWIG_UnknownError, "An unknown exception occurred", return 0); } } - fresult = static_cast< bool >(result); + fresult = (result ? 1 : 0); return fresult; } @@ -3543,7 +3543,7 @@ SWIGEXPORT SwigClassWrapper _wrap_new_TpetraMultiVector__SWIG_0() { } -SWIGEXPORT SwigClassWrapper _wrap_new_TpetraMultiVector__SWIG_1(SwigClassWrapper const *farg1, size_t const *farg2, bool const *farg3) { +SWIGEXPORT SwigClassWrapper _wrap_new_TpetraMultiVector__SWIG_1(SwigClassWrapper const *farg1, size_t const *farg2, int const *farg3) { SwigClassWrapper fresult ; Teuchos::RCP< Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > *arg1 = 0 ; size_t arg2 ; @@ -3553,7 +3553,7 @@ SWIGEXPORT SwigClassWrapper _wrap_new_TpetraMultiVector__SWIG_1(SwigClassWrapper arg1 = farg1->cptr ? static_cast< Teuchos::RCP< Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg1->cptr) : &tempnull1; arg2 = static_cast< size_t >(*farg2); - arg3 = static_cast< bool >(*farg3); + arg3 = (*farg3 ? true : false); { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::MultiVector(Teuchos::RCP< Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,size_t const,bool const)");; @@ -3899,7 +3899,7 @@ SWIGEXPORT void _wrap_TpetraMultiVector_replaceGlobalValue(SwigClassWrapper cons } -SWIGEXPORT void _wrap_TpetraMultiVector_sumIntoGlobalValue__SWIG_0(SwigClassWrapper const *farg1, long long const *farg2, size_t const *farg3, double const *farg4, bool const *farg5) { +SWIGEXPORT void _wrap_TpetraMultiVector_sumIntoGlobalValue__SWIG_0(SwigClassWrapper const *farg1, long long const *farg2, size_t const *farg3, double const *farg4, int const *farg5) { Tpetra::MultiVector< SC,LO,GO,NO > *arg1 = (Tpetra::MultiVector< SC,LO,GO,NO > *) 0 ; long long arg2 ; size_t arg3 ; @@ -3914,7 +3914,7 @@ SWIGEXPORT void _wrap_TpetraMultiVector_sumIntoGlobalValue__SWIG_0(SwigClassWrap arg3 = *farg3 - 1; temp4 = static_cast< Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::impl_scalar_type >(*farg4); arg4 = &temp4; - arg5 = static_cast< bool >(*farg5); + arg5 = (*farg5 ? true : false); { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::sumIntoGlobalValue(long long const,size_t const,Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::impl_scalar_type const &,bool const) const");; @@ -4024,7 +4024,7 @@ SWIGEXPORT void _wrap_TpetraMultiVector_replaceLocalValue(SwigClassWrapper const } -SWIGEXPORT void _wrap_TpetraMultiVector_sumIntoLocalValue__SWIG_0(SwigClassWrapper const *farg1, int const *farg2, size_t const *farg3, double const *farg4, bool const *farg5) { +SWIGEXPORT void _wrap_TpetraMultiVector_sumIntoLocalValue__SWIG_0(SwigClassWrapper const *farg1, int const *farg2, size_t const *farg3, double const *farg4, int const *farg5) { Tpetra::MultiVector< SC,LO,GO,NO > *arg1 = (Tpetra::MultiVector< SC,LO,GO,NO > *) 0 ; int arg2 ; size_t arg3 ; @@ -4039,7 +4039,7 @@ SWIGEXPORT void _wrap_TpetraMultiVector_sumIntoLocalValue__SWIG_0(SwigClassWrapp arg3 = *farg3 - 1; temp4 = static_cast< Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::impl_scalar_type >(*farg4); arg4 = &temp4; - arg5 = static_cast< bool >(*farg5); + arg5 = (*farg5 ? true : false); { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::sumIntoLocalValue(int const,size_t const,Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::impl_scalar_type const &,bool const) const");; @@ -4438,8 +4438,8 @@ SWIGEXPORT void _wrap_TpetraMultiVector_sync_device(SwigClassWrapper const *farg } -SWIGEXPORT bool _wrap_TpetraMultiVector_need_sync_host(SwigClassWrapper const *farg1) { - bool fresult ; +SWIGEXPORT int _wrap_TpetraMultiVector_need_sync_host(SwigClassWrapper const *farg1) { + int fresult ; Tpetra::MultiVector< SC,LO,GO,NO > *arg1 = (Tpetra::MultiVector< SC,LO,GO,NO > *) 0 ; Teuchos::RCP< Tpetra::MultiVector< SC,LO,GO,NO > const > *smartarg1 ; bool result; @@ -4469,13 +4469,13 @@ SWIGEXPORT bool _wrap_TpetraMultiVector_need_sync_host(SwigClassWrapper const *f SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::need_sync_host() const", SWIG_UnknownError, "An unknown exception occurred", return 0); } } - fresult = static_cast< bool >(result); + fresult = (result ? 1 : 0); return fresult; } -SWIGEXPORT bool _wrap_TpetraMultiVector_need_sync_device(SwigClassWrapper const *farg1) { - bool fresult ; +SWIGEXPORT int _wrap_TpetraMultiVector_need_sync_device(SwigClassWrapper const *farg1) { + int fresult ; Tpetra::MultiVector< SC,LO,GO,NO > *arg1 = (Tpetra::MultiVector< SC,LO,GO,NO > *) 0 ; Teuchos::RCP< Tpetra::MultiVector< SC,LO,GO,NO > const > *smartarg1 ; bool result; @@ -4505,7 +4505,7 @@ SWIGEXPORT bool _wrap_TpetraMultiVector_need_sync_device(SwigClassWrapper const SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::need_sync_device() const", SWIG_UnknownError, "An unknown exception occurred", return 0); } } - fresult = static_cast< bool >(result); + fresult = (result ? 1 : 0); return fresult; } @@ -5031,8 +5031,8 @@ SWIGEXPORT size_t _wrap_TpetraMultiVector_getStride(SwigClassWrapper const *farg } -SWIGEXPORT bool _wrap_TpetraMultiVector_isConstantStride(SwigClassWrapper const *farg1) { - bool fresult ; +SWIGEXPORT int _wrap_TpetraMultiVector_isConstantStride(SwigClassWrapper const *farg1) { + int fresult ; Tpetra::MultiVector< SC,LO,GO,NO > *arg1 = (Tpetra::MultiVector< SC,LO,GO,NO > *) 0 ; Teuchos::RCP< Tpetra::MultiVector< SC,LO,GO,NO > const > *smartarg1 ; bool result; @@ -5062,7 +5062,7 @@ SWIGEXPORT bool _wrap_TpetraMultiVector_isConstantStride(SwigClassWrapper const SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::isConstantStride() const", SWIG_UnknownError, "An unknown exception occurred", return 0); } } - fresult = static_cast< bool >(result); + fresult = (result ? 1 : 0); return fresult; } @@ -5216,8 +5216,8 @@ SWIGEXPORT int _wrap_TpetraMultiVector_getCopyOrView(SwigClassWrapper const *far } -SWIGEXPORT bool _wrap_TpetraMultiVector_isSameSize(SwigClassWrapper const *farg1, SwigClassWrapper const *farg2) { - bool fresult ; +SWIGEXPORT int _wrap_TpetraMultiVector_isSameSize(SwigClassWrapper const *farg1, SwigClassWrapper const *farg2) { + int fresult ; Tpetra::MultiVector< SC,LO,GO,NO > *arg1 = (Tpetra::MultiVector< SC,LO,GO,NO > *) 0 ; Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > *arg2 = 0 ; Teuchos::RCP< Tpetra::MultiVector< SC,LO,GO,NO > const > *smartarg1 ; @@ -5252,7 +5252,7 @@ SWIGEXPORT bool _wrap_TpetraMultiVector_isSameSize(SwigClassWrapper const *farg1 SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::isSameSize(Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &) const", SWIG_UnknownError, "An unknown exception occurred", return 0); } } - fresult = static_cast< bool >(result); + fresult = (result ? 1 : 0); return fresult; } @@ -6860,8 +6860,8 @@ SWIGEXPORT void _wrap_TpetraCrsGraph_swap(SwigClassWrapper const *farg1, SwigCla } -SWIGEXPORT bool _wrap_TpetraCrsGraph_isIdenticalTo(SwigClassWrapper const *farg1, SwigClassWrapper const *farg2) { - bool fresult ; +SWIGEXPORT int _wrap_TpetraCrsGraph_isIdenticalTo(SwigClassWrapper const *farg1, SwigClassWrapper const *farg2) { + int fresult ; Tpetra::CrsGraph< LO,GO,NO > *arg1 = (Tpetra::CrsGraph< LO,GO,NO > *) 0 ; Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode > *arg2 = 0 ; Teuchos::RCP< Tpetra::CrsGraph< LO,GO,NO > const > *smartarg1 ; @@ -6896,7 +6896,7 @@ SWIGEXPORT bool _wrap_TpetraCrsGraph_isIdenticalTo(SwigClassWrapper const *farg1 SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::isIdenticalTo(Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &) const", SWIG_UnknownError, "An unknown exception occurred", return 0); } } - fresult = static_cast< bool >(result); + fresult = (result ? 1 : 0); return fresult; } @@ -8353,8 +8353,8 @@ SWIGEXPORT size_t _wrap_TpetraCrsGraph_getNodeMaxNumRowEntries(SwigClassWrapper } -SWIGEXPORT bool _wrap_TpetraCrsGraph_hasColMap(SwigClassWrapper const *farg1) { - bool fresult ; +SWIGEXPORT int _wrap_TpetraCrsGraph_hasColMap(SwigClassWrapper const *farg1) { + int fresult ; Tpetra::CrsGraph< LO,GO,NO > *arg1 = (Tpetra::CrsGraph< LO,GO,NO > *) 0 ; Teuchos::RCP< Tpetra::CrsGraph< LO,GO,NO > const > *smartarg1 ; bool result; @@ -8384,13 +8384,13 @@ SWIGEXPORT bool _wrap_TpetraCrsGraph_hasColMap(SwigClassWrapper const *farg1) { SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::hasColMap() const", SWIG_UnknownError, "An unknown exception occurred", return 0); } } - fresult = static_cast< bool >(result); + fresult = (result ? 1 : 0); return fresult; } -SWIGEXPORT bool _wrap_TpetraCrsGraph_isLowerTriangularImpl(SwigClassWrapper const *farg1) { - bool fresult ; +SWIGEXPORT int _wrap_TpetraCrsGraph_isLowerTriangularImpl(SwigClassWrapper const *farg1) { + int fresult ; Tpetra::CrsGraph< LO,GO,NO > *arg1 = (Tpetra::CrsGraph< LO,GO,NO > *) 0 ; Teuchos::RCP< Tpetra::CrsGraph< LO,GO,NO > const > *smartarg1 ; bool result; @@ -8420,13 +8420,13 @@ SWIGEXPORT bool _wrap_TpetraCrsGraph_isLowerTriangularImpl(SwigClassWrapper cons SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::isLowerTriangularImpl() const", SWIG_UnknownError, "An unknown exception occurred", return 0); } } - fresult = static_cast< bool >(result); + fresult = (result ? 1 : 0); return fresult; } -SWIGEXPORT bool _wrap_TpetraCrsGraph_isLowerTriangular(SwigClassWrapper const *farg1) { - bool fresult ; +SWIGEXPORT int _wrap_TpetraCrsGraph_isLowerTriangular(SwigClassWrapper const *farg1) { + int fresult ; Tpetra::CrsGraph< LO,GO,NO > *arg1 = (Tpetra::CrsGraph< LO,GO,NO > *) 0 ; Teuchos::RCP< Tpetra::CrsGraph< LO,GO,NO > const > *smartarg1 ; bool result; @@ -8456,13 +8456,13 @@ SWIGEXPORT bool _wrap_TpetraCrsGraph_isLowerTriangular(SwigClassWrapper const *f SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::isLowerTriangular() const", SWIG_UnknownError, "An unknown exception occurred", return 0); } } - fresult = static_cast< bool >(result); + fresult = (result ? 1 : 0); return fresult; } -SWIGEXPORT bool _wrap_TpetraCrsGraph_isUpperTriangularImpl(SwigClassWrapper const *farg1) { - bool fresult ; +SWIGEXPORT int _wrap_TpetraCrsGraph_isUpperTriangularImpl(SwigClassWrapper const *farg1) { + int fresult ; Tpetra::CrsGraph< LO,GO,NO > *arg1 = (Tpetra::CrsGraph< LO,GO,NO > *) 0 ; Teuchos::RCP< Tpetra::CrsGraph< LO,GO,NO > const > *smartarg1 ; bool result; @@ -8492,13 +8492,13 @@ SWIGEXPORT bool _wrap_TpetraCrsGraph_isUpperTriangularImpl(SwigClassWrapper cons SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::isUpperTriangularImpl() const", SWIG_UnknownError, "An unknown exception occurred", return 0); } } - fresult = static_cast< bool >(result); + fresult = (result ? 1 : 0); return fresult; } -SWIGEXPORT bool _wrap_TpetraCrsGraph_isUpperTriangular(SwigClassWrapper const *farg1) { - bool fresult ; +SWIGEXPORT int _wrap_TpetraCrsGraph_isUpperTriangular(SwigClassWrapper const *farg1) { + int fresult ; Tpetra::CrsGraph< LO,GO,NO > *arg1 = (Tpetra::CrsGraph< LO,GO,NO > *) 0 ; Teuchos::RCP< Tpetra::CrsGraph< LO,GO,NO > const > *smartarg1 ; bool result; @@ -8528,13 +8528,13 @@ SWIGEXPORT bool _wrap_TpetraCrsGraph_isUpperTriangular(SwigClassWrapper const *f SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::isUpperTriangular() const", SWIG_UnknownError, "An unknown exception occurred", return 0); } } - fresult = static_cast< bool >(result); + fresult = (result ? 1 : 0); return fresult; } -SWIGEXPORT bool _wrap_TpetraCrsGraph_isLocallyIndexed(SwigClassWrapper const *farg1) { - bool fresult ; +SWIGEXPORT int _wrap_TpetraCrsGraph_isLocallyIndexed(SwigClassWrapper const *farg1) { + int fresult ; Tpetra::CrsGraph< LO,GO,NO > *arg1 = (Tpetra::CrsGraph< LO,GO,NO > *) 0 ; Teuchos::RCP< Tpetra::CrsGraph< LO,GO,NO > const > *smartarg1 ; bool result; @@ -8564,13 +8564,13 @@ SWIGEXPORT bool _wrap_TpetraCrsGraph_isLocallyIndexed(SwigClassWrapper const *fa SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::isLocallyIndexed() const", SWIG_UnknownError, "An unknown exception occurred", return 0); } } - fresult = static_cast< bool >(result); + fresult = (result ? 1 : 0); return fresult; } -SWIGEXPORT bool _wrap_TpetraCrsGraph_isGloballyIndexed(SwigClassWrapper const *farg1) { - bool fresult ; +SWIGEXPORT int _wrap_TpetraCrsGraph_isGloballyIndexed(SwigClassWrapper const *farg1) { + int fresult ; Tpetra::CrsGraph< LO,GO,NO > *arg1 = (Tpetra::CrsGraph< LO,GO,NO > *) 0 ; Teuchos::RCP< Tpetra::CrsGraph< LO,GO,NO > const > *smartarg1 ; bool result; @@ -8600,13 +8600,13 @@ SWIGEXPORT bool _wrap_TpetraCrsGraph_isGloballyIndexed(SwigClassWrapper const *f SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::isGloballyIndexed() const", SWIG_UnknownError, "An unknown exception occurred", return 0); } } - fresult = static_cast< bool >(result); + fresult = (result ? 1 : 0); return fresult; } -SWIGEXPORT bool _wrap_TpetraCrsGraph_isFillComplete(SwigClassWrapper const *farg1) { - bool fresult ; +SWIGEXPORT int _wrap_TpetraCrsGraph_isFillComplete(SwigClassWrapper const *farg1) { + int fresult ; Tpetra::CrsGraph< LO,GO,NO > *arg1 = (Tpetra::CrsGraph< LO,GO,NO > *) 0 ; Teuchos::RCP< Tpetra::CrsGraph< LO,GO,NO > const > *smartarg1 ; bool result; @@ -8636,13 +8636,13 @@ SWIGEXPORT bool _wrap_TpetraCrsGraph_isFillComplete(SwigClassWrapper const *farg SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::isFillComplete() const", SWIG_UnknownError, "An unknown exception occurred", return 0); } } - fresult = static_cast< bool >(result); + fresult = (result ? 1 : 0); return fresult; } -SWIGEXPORT bool _wrap_TpetraCrsGraph_isFillActive(SwigClassWrapper const *farg1) { - bool fresult ; +SWIGEXPORT int _wrap_TpetraCrsGraph_isFillActive(SwigClassWrapper const *farg1) { + int fresult ; Tpetra::CrsGraph< LO,GO,NO > *arg1 = (Tpetra::CrsGraph< LO,GO,NO > *) 0 ; Teuchos::RCP< Tpetra::CrsGraph< LO,GO,NO > const > *smartarg1 ; bool result; @@ -8672,13 +8672,13 @@ SWIGEXPORT bool _wrap_TpetraCrsGraph_isFillActive(SwigClassWrapper const *farg1) SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::isFillActive() const", SWIG_UnknownError, "An unknown exception occurred", return 0); } } - fresult = static_cast< bool >(result); + fresult = (result ? 1 : 0); return fresult; } -SWIGEXPORT bool _wrap_TpetraCrsGraph_isSorted(SwigClassWrapper const *farg1) { - bool fresult ; +SWIGEXPORT int _wrap_TpetraCrsGraph_isSorted(SwigClassWrapper const *farg1) { + int fresult ; Tpetra::CrsGraph< LO,GO,NO > *arg1 = (Tpetra::CrsGraph< LO,GO,NO > *) 0 ; Teuchos::RCP< Tpetra::CrsGraph< LO,GO,NO > const > *smartarg1 ; bool result; @@ -8708,13 +8708,13 @@ SWIGEXPORT bool _wrap_TpetraCrsGraph_isSorted(SwigClassWrapper const *farg1) { SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::isSorted() const", SWIG_UnknownError, "An unknown exception occurred", return 0); } } - fresult = static_cast< bool >(result); + fresult = (result ? 1 : 0); return fresult; } -SWIGEXPORT bool _wrap_TpetraCrsGraph_isStorageOptimized(SwigClassWrapper const *farg1) { - bool fresult ; +SWIGEXPORT int _wrap_TpetraCrsGraph_isStorageOptimized(SwigClassWrapper const *farg1) { + int fresult ; Tpetra::CrsGraph< LO,GO,NO > *arg1 = (Tpetra::CrsGraph< LO,GO,NO > *) 0 ; Teuchos::RCP< Tpetra::CrsGraph< LO,GO,NO > const > *smartarg1 ; bool result; @@ -8744,7 +8744,7 @@ SWIGEXPORT bool _wrap_TpetraCrsGraph_isStorageOptimized(SwigClassWrapper const * SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::isStorageOptimized() const", SWIG_UnknownError, "An unknown exception occurred", return 0); } } - fresult = static_cast< bool >(result); + fresult = (result ? 1 : 0); return fresult; } @@ -8785,8 +8785,8 @@ SWIGEXPORT int _wrap_TpetraCrsGraph_getProfileType(SwigClassWrapper const *farg1 } -SWIGEXPORT bool _wrap_TpetraCrsGraph_supportsRowViews(SwigClassWrapper const *farg1) { - bool fresult ; +SWIGEXPORT int _wrap_TpetraCrsGraph_supportsRowViews(SwigClassWrapper const *farg1) { + int fresult ; Tpetra::CrsGraph< LO,GO,NO > *arg1 = (Tpetra::CrsGraph< LO,GO,NO > *) 0 ; Teuchos::RCP< Tpetra::CrsGraph< LO,GO,NO > const > *smartarg1 ; bool result; @@ -8816,7 +8816,7 @@ SWIGEXPORT bool _wrap_TpetraCrsGraph_supportsRowViews(SwigClassWrapper const *fa SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::supportsRowViews() const", SWIG_UnknownError, "An unknown exception occurred", return 0); } } - fresult = static_cast< bool >(result); + fresult = (result ? 1 : 0); return fresult; } @@ -8899,7 +8899,7 @@ SWIGEXPORT void _wrap_TpetraCrsGraph_replaceColMap(SwigClassWrapper const *farg1 } -SWIGEXPORT void _wrap_TpetraCrsGraph_reindexColumns__SWIG_0(SwigClassWrapper const *farg1, SwigClassWrapper const *farg2, SwigClassWrapper const *farg3, bool const *farg4) { +SWIGEXPORT void _wrap_TpetraCrsGraph_reindexColumns__SWIG_0(SwigClassWrapper const *farg1, SwigClassWrapper const *farg2, SwigClassWrapper const *farg3, int const *farg4) { Tpetra::CrsGraph< LO,GO,NO > *arg1 = (Tpetra::CrsGraph< LO,GO,NO > *) 0 ; Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > *arg2 = 0 ; Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::import_type const > *arg3 = 0 ; @@ -8912,7 +8912,7 @@ SWIGEXPORT void _wrap_TpetraCrsGraph_reindexColumns__SWIG_0(SwigClassWrapper con arg1 = smartarg1 ? const_cast< Tpetra::CrsGraph* >(smartarg1->get()) : NULL; arg2 = farg2->cptr ? static_cast< Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg2->cptr) : &tempnull2; arg3 = farg3->cptr ? static_cast< Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::import_type const > * >(farg3->cptr) : &tempnull3; - arg4 = static_cast< bool >(*farg4); + arg4 = (*farg4 ? true : false); { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::reindexColumns(Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::import_type const > const &,bool const)");; @@ -9479,8 +9479,8 @@ SWIGEXPORT void _wrap_TpetraCrsGraph_exportAndFillComplete__SWIG_4(SwigClassWrap } -SWIGEXPORT bool _wrap_TpetraCrsGraph_haveGlobalConstants(SwigClassWrapper const *farg1) { - bool fresult ; +SWIGEXPORT int _wrap_TpetraCrsGraph_haveGlobalConstants(SwigClassWrapper const *farg1) { + int fresult ; Tpetra::CrsGraph< LO,GO,NO > *arg1 = (Tpetra::CrsGraph< LO,GO,NO > *) 0 ; Teuchos::RCP< Tpetra::CrsGraph< LO,GO,NO > const > *smartarg1 ; bool result; @@ -9510,19 +9510,19 @@ SWIGEXPORT bool _wrap_TpetraCrsGraph_haveGlobalConstants(SwigClassWrapper const SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::haveGlobalConstants() const", SWIG_UnknownError, "An unknown exception occurred", return 0); } } - fresult = static_cast< bool >(result); + fresult = (result ? 1 : 0); return fresult; } -SWIGEXPORT void _wrap_TpetraCrsGraph_computeGlobalConstants(SwigClassWrapper const *farg1, bool const *farg2) { +SWIGEXPORT void _wrap_TpetraCrsGraph_computeGlobalConstants(SwigClassWrapper const *farg1, int const *farg2) { Tpetra::CrsGraph< LO,GO,NO > *arg1 = (Tpetra::CrsGraph< LO,GO,NO > *) 0 ; bool arg2 ; Teuchos::RCP< Tpetra::CrsGraph< LO,GO,NO > > *smartarg1 ; smartarg1 = static_cast< Teuchos::RCP< Tpetra::CrsGraph >* >(farg1->cptr); arg1 = smartarg1 ? const_cast< Tpetra::CrsGraph* >(smartarg1->get()) : NULL; - arg2 = static_cast< bool >(*farg2); + arg2 = (*farg2 ? true : false); { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::computeGlobalConstants(bool const)");; @@ -11408,7 +11408,7 @@ SWIGEXPORT void _wrap_TpetraCrsMatrix_replaceColMap(SwigClassWrapper const *farg } -SWIGEXPORT void _wrap_TpetraCrsMatrix_reindexColumns__SWIG_0(SwigClassWrapper const *farg1, SwigClassWrapper const *farg2, SwigClassWrapper const *farg3, SwigClassWrapper const *farg4, bool const *farg5) { +SWIGEXPORT void _wrap_TpetraCrsMatrix_reindexColumns__SWIG_0(SwigClassWrapper const *farg1, SwigClassWrapper const *farg2, SwigClassWrapper const *farg3, SwigClassWrapper const *farg4, int const *farg5) { Tpetra::CrsMatrix< SC,LO,GO,NO > *arg1 = (Tpetra::CrsMatrix< SC,LO,GO,NO > *) 0 ; Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::crs_graph_type *arg2 = (Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::crs_graph_type *) (Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::crs_graph_type *)0 ; Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > *arg3 = 0 ; @@ -11425,7 +11425,7 @@ SWIGEXPORT void _wrap_TpetraCrsMatrix_reindexColumns__SWIG_0(SwigClassWrapper co arg2 = smartarg2 ? const_cast< Tpetra::CrsGraph* >(smartarg2->get()) : NULL; arg3 = farg3->cptr ? static_cast< Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg3->cptr) : &tempnull3; arg4 = farg4->cptr ? static_cast< Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::import_type const > * >(farg4->cptr) : &tempnull4; - arg5 = static_cast< bool >(*farg5); + arg5 = (*farg5 ? true : false); { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::reindexColumns(Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::crs_graph_type *const,Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::import_type const > const &,bool const)");; @@ -12267,8 +12267,8 @@ SWIGEXPORT size_t _wrap_TpetraCrsMatrix_getNodeMaxNumRowEntries(SwigClassWrapper } -SWIGEXPORT bool _wrap_TpetraCrsMatrix_hasColMap(SwigClassWrapper const *farg1) { - bool fresult ; +SWIGEXPORT int _wrap_TpetraCrsMatrix_hasColMap(SwigClassWrapper const *farg1) { + int fresult ; Tpetra::CrsMatrix< SC,LO,GO,NO > *arg1 = (Tpetra::CrsMatrix< SC,LO,GO,NO > *) 0 ; Teuchos::RCP< Tpetra::CrsMatrix< SC,LO,GO,NO > const > *smartarg1 ; bool result; @@ -12298,13 +12298,13 @@ SWIGEXPORT bool _wrap_TpetraCrsMatrix_hasColMap(SwigClassWrapper const *farg1) { SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::hasColMap() const", SWIG_UnknownError, "An unknown exception occurred", return 0); } } - fresult = static_cast< bool >(result); + fresult = (result ? 1 : 0); return fresult; } -SWIGEXPORT bool _wrap_TpetraCrsMatrix_isLowerTriangularImpl(SwigClassWrapper const *farg1) { - bool fresult ; +SWIGEXPORT int _wrap_TpetraCrsMatrix_isLowerTriangularImpl(SwigClassWrapper const *farg1) { + int fresult ; Tpetra::CrsMatrix< SC,LO,GO,NO > *arg1 = (Tpetra::CrsMatrix< SC,LO,GO,NO > *) 0 ; Teuchos::RCP< Tpetra::CrsMatrix< SC,LO,GO,NO > const > *smartarg1 ; bool result; @@ -12334,13 +12334,13 @@ SWIGEXPORT bool _wrap_TpetraCrsMatrix_isLowerTriangularImpl(SwigClassWrapper con SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::isLowerTriangularImpl() const", SWIG_UnknownError, "An unknown exception occurred", return 0); } } - fresult = static_cast< bool >(result); + fresult = (result ? 1 : 0); return fresult; } -SWIGEXPORT bool _wrap_TpetraCrsMatrix_isLowerTriangular(SwigClassWrapper const *farg1) { - bool fresult ; +SWIGEXPORT int _wrap_TpetraCrsMatrix_isLowerTriangular(SwigClassWrapper const *farg1) { + int fresult ; Tpetra::CrsMatrix< SC,LO,GO,NO > *arg1 = (Tpetra::CrsMatrix< SC,LO,GO,NO > *) 0 ; Teuchos::RCP< Tpetra::CrsMatrix< SC,LO,GO,NO > const > *smartarg1 ; bool result; @@ -12370,13 +12370,13 @@ SWIGEXPORT bool _wrap_TpetraCrsMatrix_isLowerTriangular(SwigClassWrapper const * SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::isLowerTriangular() const", SWIG_UnknownError, "An unknown exception occurred", return 0); } } - fresult = static_cast< bool >(result); + fresult = (result ? 1 : 0); return fresult; } -SWIGEXPORT bool _wrap_TpetraCrsMatrix_isUpperTriangularImpl(SwigClassWrapper const *farg1) { - bool fresult ; +SWIGEXPORT int _wrap_TpetraCrsMatrix_isUpperTriangularImpl(SwigClassWrapper const *farg1) { + int fresult ; Tpetra::CrsMatrix< SC,LO,GO,NO > *arg1 = (Tpetra::CrsMatrix< SC,LO,GO,NO > *) 0 ; Teuchos::RCP< Tpetra::CrsMatrix< SC,LO,GO,NO > const > *smartarg1 ; bool result; @@ -12406,13 +12406,13 @@ SWIGEXPORT bool _wrap_TpetraCrsMatrix_isUpperTriangularImpl(SwigClassWrapper con SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::isUpperTriangularImpl() const", SWIG_UnknownError, "An unknown exception occurred", return 0); } } - fresult = static_cast< bool >(result); + fresult = (result ? 1 : 0); return fresult; } -SWIGEXPORT bool _wrap_TpetraCrsMatrix_isUpperTriangular(SwigClassWrapper const *farg1) { - bool fresult ; +SWIGEXPORT int _wrap_TpetraCrsMatrix_isUpperTriangular(SwigClassWrapper const *farg1) { + int fresult ; Tpetra::CrsMatrix< SC,LO,GO,NO > *arg1 = (Tpetra::CrsMatrix< SC,LO,GO,NO > *) 0 ; Teuchos::RCP< Tpetra::CrsMatrix< SC,LO,GO,NO > const > *smartarg1 ; bool result; @@ -12442,13 +12442,13 @@ SWIGEXPORT bool _wrap_TpetraCrsMatrix_isUpperTriangular(SwigClassWrapper const * SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::isUpperTriangular() const", SWIG_UnknownError, "An unknown exception occurred", return 0); } } - fresult = static_cast< bool >(result); + fresult = (result ? 1 : 0); return fresult; } -SWIGEXPORT bool _wrap_TpetraCrsMatrix_isLocallyIndexed(SwigClassWrapper const *farg1) { - bool fresult ; +SWIGEXPORT int _wrap_TpetraCrsMatrix_isLocallyIndexed(SwigClassWrapper const *farg1) { + int fresult ; Tpetra::CrsMatrix< SC,LO,GO,NO > *arg1 = (Tpetra::CrsMatrix< SC,LO,GO,NO > *) 0 ; Teuchos::RCP< Tpetra::CrsMatrix< SC,LO,GO,NO > const > *smartarg1 ; bool result; @@ -12478,13 +12478,13 @@ SWIGEXPORT bool _wrap_TpetraCrsMatrix_isLocallyIndexed(SwigClassWrapper const *f SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::isLocallyIndexed() const", SWIG_UnknownError, "An unknown exception occurred", return 0); } } - fresult = static_cast< bool >(result); + fresult = (result ? 1 : 0); return fresult; } -SWIGEXPORT bool _wrap_TpetraCrsMatrix_isGloballyIndexed(SwigClassWrapper const *farg1) { - bool fresult ; +SWIGEXPORT int _wrap_TpetraCrsMatrix_isGloballyIndexed(SwigClassWrapper const *farg1) { + int fresult ; Tpetra::CrsMatrix< SC,LO,GO,NO > *arg1 = (Tpetra::CrsMatrix< SC,LO,GO,NO > *) 0 ; Teuchos::RCP< Tpetra::CrsMatrix< SC,LO,GO,NO > const > *smartarg1 ; bool result; @@ -12514,13 +12514,13 @@ SWIGEXPORT bool _wrap_TpetraCrsMatrix_isGloballyIndexed(SwigClassWrapper const * SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::isGloballyIndexed() const", SWIG_UnknownError, "An unknown exception occurred", return 0); } } - fresult = static_cast< bool >(result); + fresult = (result ? 1 : 0); return fresult; } -SWIGEXPORT bool _wrap_TpetraCrsMatrix_isFillComplete(SwigClassWrapper const *farg1) { - bool fresult ; +SWIGEXPORT int _wrap_TpetraCrsMatrix_isFillComplete(SwigClassWrapper const *farg1) { + int fresult ; Tpetra::CrsMatrix< SC,LO,GO,NO > *arg1 = (Tpetra::CrsMatrix< SC,LO,GO,NO > *) 0 ; Teuchos::RCP< Tpetra::CrsMatrix< SC,LO,GO,NO > const > *smartarg1 ; bool result; @@ -12550,13 +12550,13 @@ SWIGEXPORT bool _wrap_TpetraCrsMatrix_isFillComplete(SwigClassWrapper const *far SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::isFillComplete() const", SWIG_UnknownError, "An unknown exception occurred", return 0); } } - fresult = static_cast< bool >(result); + fresult = (result ? 1 : 0); return fresult; } -SWIGEXPORT bool _wrap_TpetraCrsMatrix_isFillActive(SwigClassWrapper const *farg1) { - bool fresult ; +SWIGEXPORT int _wrap_TpetraCrsMatrix_isFillActive(SwigClassWrapper const *farg1) { + int fresult ; Tpetra::CrsMatrix< SC,LO,GO,NO > *arg1 = (Tpetra::CrsMatrix< SC,LO,GO,NO > *) 0 ; Teuchos::RCP< Tpetra::CrsMatrix< SC,LO,GO,NO > const > *smartarg1 ; bool result; @@ -12586,13 +12586,13 @@ SWIGEXPORT bool _wrap_TpetraCrsMatrix_isFillActive(SwigClassWrapper const *farg1 SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::isFillActive() const", SWIG_UnknownError, "An unknown exception occurred", return 0); } } - fresult = static_cast< bool >(result); + fresult = (result ? 1 : 0); return fresult; } -SWIGEXPORT bool _wrap_TpetraCrsMatrix_isStorageOptimized(SwigClassWrapper const *farg1) { - bool fresult ; +SWIGEXPORT int _wrap_TpetraCrsMatrix_isStorageOptimized(SwigClassWrapper const *farg1) { + int fresult ; Tpetra::CrsMatrix< SC,LO,GO,NO > *arg1 = (Tpetra::CrsMatrix< SC,LO,GO,NO > *) 0 ; Teuchos::RCP< Tpetra::CrsMatrix< SC,LO,GO,NO > const > *smartarg1 ; bool result; @@ -12622,7 +12622,7 @@ SWIGEXPORT bool _wrap_TpetraCrsMatrix_isStorageOptimized(SwigClassWrapper const SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::isStorageOptimized() const", SWIG_UnknownError, "An unknown exception occurred", return 0); } } - fresult = static_cast< bool >(result); + fresult = (result ? 1 : 0); return fresult; } @@ -12663,8 +12663,8 @@ SWIGEXPORT int _wrap_TpetraCrsMatrix_getProfileType(SwigClassWrapper const *farg } -SWIGEXPORT bool _wrap_TpetraCrsMatrix_isStaticGraph(SwigClassWrapper const *farg1) { - bool fresult ; +SWIGEXPORT int _wrap_TpetraCrsMatrix_isStaticGraph(SwigClassWrapper const *farg1) { + int fresult ; Tpetra::CrsMatrix< SC,LO,GO,NO > *arg1 = (Tpetra::CrsMatrix< SC,LO,GO,NO > *) 0 ; Teuchos::RCP< Tpetra::CrsMatrix< SC,LO,GO,NO > const > *smartarg1 ; bool result; @@ -12694,7 +12694,7 @@ SWIGEXPORT bool _wrap_TpetraCrsMatrix_isStaticGraph(SwigClassWrapper const *farg SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::isStaticGraph() const", SWIG_UnknownError, "An unknown exception occurred", return 0); } } - fresult = static_cast< bool >(result); + fresult = (result ? 1 : 0); return fresult; } @@ -12735,8 +12735,8 @@ SWIGEXPORT double _wrap_TpetraCrsMatrix_getFrobeniusNorm(SwigClassWrapper const } -SWIGEXPORT bool _wrap_TpetraCrsMatrix_supportsRowViews(SwigClassWrapper const *farg1) { - bool fresult ; +SWIGEXPORT int _wrap_TpetraCrsMatrix_supportsRowViews(SwigClassWrapper const *farg1) { + int fresult ; Tpetra::CrsMatrix< SC,LO,GO,NO > *arg1 = (Tpetra::CrsMatrix< SC,LO,GO,NO > *) 0 ; Teuchos::RCP< Tpetra::CrsMatrix< SC,LO,GO,NO > const > *smartarg1 ; bool result; @@ -12766,7 +12766,7 @@ SWIGEXPORT bool _wrap_TpetraCrsMatrix_supportsRowViews(SwigClassWrapper const *f SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::supportsRowViews() const", SWIG_UnknownError, "An unknown exception occurred", return 0); } } - fresult = static_cast< bool >(result); + fresult = (result ? 1 : 0); return fresult; } @@ -12955,8 +12955,8 @@ SWIGEXPORT void _wrap_TpetraCrsMatrix_apply__SWIG_3(SwigClassWrapper const *farg } -SWIGEXPORT bool _wrap_TpetraCrsMatrix_hasTransposeApply(SwigClassWrapper const *farg1) { - bool fresult ; +SWIGEXPORT int _wrap_TpetraCrsMatrix_hasTransposeApply(SwigClassWrapper const *farg1) { + int fresult ; Tpetra::CrsMatrix< SC,LO,GO,NO > *arg1 = (Tpetra::CrsMatrix< SC,LO,GO,NO > *) 0 ; Teuchos::RCP< Tpetra::CrsMatrix< SC,LO,GO,NO > const > *smartarg1 ; bool result; @@ -12986,7 +12986,7 @@ SWIGEXPORT bool _wrap_TpetraCrsMatrix_hasTransposeApply(SwigClassWrapper const * SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::hasTransposeApply() const", SWIG_UnknownError, "An unknown exception occurred", return 0); } } - fresult = static_cast< bool >(result); + fresult = (result ? 1 : 0); return fresult; } @@ -13121,7 +13121,7 @@ SWIGEXPORT void _wrap_TpetraCrsMatrix_gaussSeidel(SwigClassWrapper const *farg1, } -SWIGEXPORT void _wrap_TpetraCrsMatrix_gaussSeidelCopy(SwigClassWrapper const *farg1, SwigClassWrapper const *farg2, SwigClassWrapper const *farg3, SwigClassWrapper const *farg4, double const *farg5, int const *farg6, int const *farg7, bool const *farg8) { +SWIGEXPORT void _wrap_TpetraCrsMatrix_gaussSeidelCopy(SwigClassWrapper const *farg1, SwigClassWrapper const *farg2, SwigClassWrapper const *farg3, SwigClassWrapper const *farg4, double const *farg5, int const *farg6, int const *farg7, int const *farg8) { Tpetra::CrsMatrix< SC,LO,GO,NO > *arg1 = (Tpetra::CrsMatrix< SC,LO,GO,NO > *) 0 ; Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > *arg2 = 0 ; Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > *arg3 = 0 ; @@ -13151,7 +13151,7 @@ SWIGEXPORT void _wrap_TpetraCrsMatrix_gaussSeidelCopy(SwigClassWrapper const *fa arg5 = &temp5; arg6 = static_cast< Tpetra::ESweepDirection >(*farg6); arg7 = static_cast< int >(*farg7); - arg8 = static_cast< bool >(*farg8); + arg8 = (*farg8 ? true : false); { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::gaussSeidelCopy(Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > &,Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &,Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &,double const &,Tpetra::ESweepDirection const,int const,bool const) const");; @@ -13643,8 +13643,8 @@ SWIGEXPORT void _wrap_TpetraCrsMatrix_computeGlobalConstants(SwigClassWrapper co } -SWIGEXPORT bool _wrap_TpetraCrsMatrix_haveGlobalConstants(SwigClassWrapper const *farg1) { - bool fresult ; +SWIGEXPORT int _wrap_TpetraCrsMatrix_haveGlobalConstants(SwigClassWrapper const *farg1) { + int fresult ; Tpetra::CrsMatrix< SC,LO,GO,NO > *arg1 = (Tpetra::CrsMatrix< SC,LO,GO,NO > *) 0 ; Teuchos::RCP< Tpetra::CrsMatrix< SC,LO,GO,NO > const > *smartarg1 ; bool result; @@ -13674,7 +13674,7 @@ SWIGEXPORT bool _wrap_TpetraCrsMatrix_haveGlobalConstants(SwigClassWrapper const SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::haveGlobalConstants() const", SWIG_UnknownError, "An unknown exception occurred", return 0); } } - fresult = static_cast< bool >(result); + fresult = (result ? 1 : 0); return fresult; } @@ -14710,7 +14710,7 @@ SWIGEXPORT SwigClassWrapper _wrap_matrix_to_operator(SwigClassWrapper const *far } -SWIGEXPORT SwigClassWrapper _wrap_TpetraReader_readSparseGraphFile__SWIG_0(SwigArrayWrapper *farg1, SwigClassWrapper const *farg2, bool const *farg3, bool const *farg4, bool const *farg5) { +SWIGEXPORT SwigClassWrapper _wrap_TpetraReader_readSparseGraphFile__SWIG_0(SwigArrayWrapper *farg1, SwigClassWrapper const *farg2, int const *farg3, int const *farg4, int const *farg5) { SwigClassWrapper fresult ; std::string *arg1 = 0 ; Teuchos::RCP< Teuchos::Comm< int > const > *arg2 = 0 ; @@ -14724,9 +14724,9 @@ SWIGEXPORT SwigClassWrapper _wrap_TpetraReader_readSparseGraphFile__SWIG_0(SwigA tempstr1 = std::string(static_cast(farg1->data), farg1->size); arg1 = &tempstr1; arg2 = farg2->cptr ? static_cast< Teuchos::RCP< Teuchos::Comm< int > const > * >(farg2->cptr) : &tempnull2; - arg3 = static_cast< bool >(*farg3); - arg4 = static_cast< bool >(*farg4); - arg5 = static_cast< bool >(*farg5); + arg3 = (*farg3 ? true : false); + arg4 = (*farg4 ? true : false); + arg5 = (*farg5 ? true : false); { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::MatrixMarket::Reader< CMT >::Tpetra_MatrixMarket_Reader_Sl_CMT_Sg__readSparseGraphFile__SWIG_0(std::string const &,Teuchos::RCP< Teuchos::Comm< int > const > const &,bool const,bool const,bool const)");; @@ -14756,7 +14756,7 @@ SWIGEXPORT SwigClassWrapper _wrap_TpetraReader_readSparseGraphFile__SWIG_0(SwigA } -SWIGEXPORT SwigClassWrapper _wrap_TpetraReader_readSparseGraphFile__SWIG_1(SwigArrayWrapper *farg1, SwigClassWrapper const *farg2, bool const *farg3, bool const *farg4) { +SWIGEXPORT SwigClassWrapper _wrap_TpetraReader_readSparseGraphFile__SWIG_1(SwigArrayWrapper *farg1, SwigClassWrapper const *farg2, int const *farg3, int const *farg4) { SwigClassWrapper fresult ; std::string *arg1 = 0 ; Teuchos::RCP< Teuchos::Comm< int > const > *arg2 = 0 ; @@ -14769,8 +14769,8 @@ SWIGEXPORT SwigClassWrapper _wrap_TpetraReader_readSparseGraphFile__SWIG_1(SwigA tempstr1 = std::string(static_cast(farg1->data), farg1->size); arg1 = &tempstr1; arg2 = farg2->cptr ? static_cast< Teuchos::RCP< Teuchos::Comm< int > const > * >(farg2->cptr) : &tempnull2; - arg3 = static_cast< bool >(*farg3); - arg4 = static_cast< bool >(*farg4); + arg3 = (*farg3 ? true : false); + arg4 = (*farg4 ? true : false); { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::MatrixMarket::Reader< CMT >::Tpetra_MatrixMarket_Reader_Sl_CMT_Sg__readSparseGraphFile__SWIG_0(std::string const &,Teuchos::RCP< Teuchos::Comm< int > const > const &,bool const,bool const)");; @@ -14800,7 +14800,7 @@ SWIGEXPORT SwigClassWrapper _wrap_TpetraReader_readSparseGraphFile__SWIG_1(SwigA } -SWIGEXPORT SwigClassWrapper _wrap_TpetraReader_readSparseGraphFile__SWIG_2(SwigArrayWrapper *farg1, SwigClassWrapper const *farg2, bool const *farg3) { +SWIGEXPORT SwigClassWrapper _wrap_TpetraReader_readSparseGraphFile__SWIG_2(SwigArrayWrapper *farg1, SwigClassWrapper const *farg2, int const *farg3) { SwigClassWrapper fresult ; std::string *arg1 = 0 ; Teuchos::RCP< Teuchos::Comm< int > const > *arg2 = 0 ; @@ -14812,7 +14812,7 @@ SWIGEXPORT SwigClassWrapper _wrap_TpetraReader_readSparseGraphFile__SWIG_2(SwigA tempstr1 = std::string(static_cast(farg1->data), farg1->size); arg1 = &tempstr1; arg2 = farg2->cptr ? static_cast< Teuchos::RCP< Teuchos::Comm< int > const > * >(farg2->cptr) : &tempnull2; - arg3 = static_cast< bool >(*farg3); + arg3 = (*farg3 ? true : false); { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::MatrixMarket::Reader< CMT >::Tpetra_MatrixMarket_Reader_Sl_CMT_Sg__readSparseGraphFile__SWIG_0(std::string const &,Teuchos::RCP< Teuchos::Comm< int > const > const &,bool const)");; @@ -14882,7 +14882,7 @@ SWIGEXPORT SwigClassWrapper _wrap_TpetraReader_readSparseGraphFile__SWIG_3(SwigA } -SWIGEXPORT SwigClassWrapper _wrap_TpetraReader_readSparseGraphFile__SWIG_4(SwigArrayWrapper *farg1, SwigClassWrapper const *farg2, SwigClassWrapper const *farg3, SwigClassWrapper const *farg4, bool const *farg5, bool const *farg6) { +SWIGEXPORT SwigClassWrapper _wrap_TpetraReader_readSparseGraphFile__SWIG_4(SwigArrayWrapper *farg1, SwigClassWrapper const *farg2, SwigClassWrapper const *farg3, SwigClassWrapper const *farg4, int const *farg5, int const *farg6) { SwigClassWrapper fresult ; std::string *arg1 = 0 ; Teuchos::RCP< Teuchos::Comm< int > const > *arg2 = 0 ; @@ -14901,8 +14901,8 @@ SWIGEXPORT SwigClassWrapper _wrap_TpetraReader_readSparseGraphFile__SWIG_4(SwigA arg2 = farg2->cptr ? static_cast< Teuchos::RCP< Teuchos::Comm< int > const > * >(farg2->cptr) : &tempnull2; arg3 = farg3->cptr ? static_cast< Teuchos::RCP< Teuchos::ParameterList > * >(farg3->cptr) : &tempnull3; arg4 = farg4->cptr ? static_cast< Teuchos::RCP< Teuchos::ParameterList > * >(farg4->cptr) : &tempnull4; - arg5 = static_cast< bool >(*farg5); - arg6 = static_cast< bool >(*farg6); + arg5 = (*farg5 ? true : false); + arg6 = (*farg6 ? true : false); { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::MatrixMarket::Reader< CMT >::Tpetra_MatrixMarket_Reader_Sl_CMT_Sg__readSparseGraphFile__SWIG_4(std::string const &,Teuchos::RCP< Teuchos::Comm< int > const > const &,Teuchos::RCP< Teuchos::ParameterList > const &,Teuchos::RCP< Teuchos::ParameterList > const &,bool const,bool const)");; @@ -14932,7 +14932,7 @@ SWIGEXPORT SwigClassWrapper _wrap_TpetraReader_readSparseGraphFile__SWIG_4(SwigA } -SWIGEXPORT SwigClassWrapper _wrap_TpetraReader_readSparseGraphFile__SWIG_5(SwigArrayWrapper *farg1, SwigClassWrapper const *farg2, SwigClassWrapper const *farg3, SwigClassWrapper const *farg4, bool const *farg5) { +SWIGEXPORT SwigClassWrapper _wrap_TpetraReader_readSparseGraphFile__SWIG_5(SwigArrayWrapper *farg1, SwigClassWrapper const *farg2, SwigClassWrapper const *farg3, SwigClassWrapper const *farg4, int const *farg5) { SwigClassWrapper fresult ; std::string *arg1 = 0 ; Teuchos::RCP< Teuchos::Comm< int > const > *arg2 = 0 ; @@ -14950,7 +14950,7 @@ SWIGEXPORT SwigClassWrapper _wrap_TpetraReader_readSparseGraphFile__SWIG_5(SwigA arg2 = farg2->cptr ? static_cast< Teuchos::RCP< Teuchos::Comm< int > const > * >(farg2->cptr) : &tempnull2; arg3 = farg3->cptr ? static_cast< Teuchos::RCP< Teuchos::ParameterList > * >(farg3->cptr) : &tempnull3; arg4 = farg4->cptr ? static_cast< Teuchos::RCP< Teuchos::ParameterList > * >(farg4->cptr) : &tempnull4; - arg5 = static_cast< bool >(*farg5); + arg5 = (*farg5 ? true : false); { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::MatrixMarket::Reader< CMT >::Tpetra_MatrixMarket_Reader_Sl_CMT_Sg__readSparseGraphFile__SWIG_4(std::string const &,Teuchos::RCP< Teuchos::Comm< int > const > const &,Teuchos::RCP< Teuchos::ParameterList > const &,Teuchos::RCP< Teuchos::ParameterList > const &,bool const)");; @@ -15026,7 +15026,7 @@ SWIGEXPORT SwigClassWrapper _wrap_TpetraReader_readSparseGraphFile__SWIG_6(SwigA } -SWIGEXPORT SwigClassWrapper _wrap_TpetraReader_readSparseGraphFile__SWIG_7(SwigArrayWrapper *farg1, SwigClassWrapper const *farg2, SwigClassWrapper const *farg3, SwigClassWrapper const *farg4, SwigClassWrapper const *farg5, bool const *farg6, bool const *farg7, bool const *farg8) { +SWIGEXPORT SwigClassWrapper _wrap_TpetraReader_readSparseGraphFile__SWIG_7(SwigArrayWrapper *farg1, SwigClassWrapper const *farg2, SwigClassWrapper const *farg3, SwigClassWrapper const *farg4, SwigClassWrapper const *farg5, int const *farg6, int const *farg7, int const *farg8) { SwigClassWrapper fresult ; std::string *arg1 = 0 ; Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > *arg2 = 0 ; @@ -15049,9 +15049,9 @@ SWIGEXPORT SwigClassWrapper _wrap_TpetraReader_readSparseGraphFile__SWIG_7(SwigA arg3 = farg3->cptr ? static_cast< Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > * >(farg3->cptr) : &tempnull3; arg4 = farg4->cptr ? static_cast< Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > * >(farg4->cptr) : &tempnull4; arg5 = farg5->cptr ? static_cast< Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > * >(farg5->cptr) : &tempnull5; - arg6 = static_cast< bool >(*farg6); - arg7 = static_cast< bool >(*farg7); - arg8 = static_cast< bool >(*farg8); + arg6 = (*farg6 ? true : false); + arg7 = (*farg7 ? true : false); + arg8 = (*farg8 ? true : false); { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::MatrixMarket::Reader< CMT >::Tpetra_MatrixMarket_Reader_Sl_CMT_Sg__readSparseGraphFile__SWIG_7(std::string const &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > const &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > const &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > const &,bool const,bool const,bool const)");; @@ -15081,7 +15081,7 @@ SWIGEXPORT SwigClassWrapper _wrap_TpetraReader_readSparseGraphFile__SWIG_7(SwigA } -SWIGEXPORT SwigClassWrapper _wrap_TpetraReader_readSparseGraphFile__SWIG_8(SwigArrayWrapper *farg1, SwigClassWrapper const *farg2, SwigClassWrapper const *farg3, SwigClassWrapper const *farg4, SwigClassWrapper const *farg5, bool const *farg6, bool const *farg7) { +SWIGEXPORT SwigClassWrapper _wrap_TpetraReader_readSparseGraphFile__SWIG_8(SwigArrayWrapper *farg1, SwigClassWrapper const *farg2, SwigClassWrapper const *farg3, SwigClassWrapper const *farg4, SwigClassWrapper const *farg5, int const *farg6, int const *farg7) { SwigClassWrapper fresult ; std::string *arg1 = 0 ; Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > *arg2 = 0 ; @@ -15103,8 +15103,8 @@ SWIGEXPORT SwigClassWrapper _wrap_TpetraReader_readSparseGraphFile__SWIG_8(SwigA arg3 = farg3->cptr ? static_cast< Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > * >(farg3->cptr) : &tempnull3; arg4 = farg4->cptr ? static_cast< Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > * >(farg4->cptr) : &tempnull4; arg5 = farg5->cptr ? static_cast< Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > * >(farg5->cptr) : &tempnull5; - arg6 = static_cast< bool >(*farg6); - arg7 = static_cast< bool >(*farg7); + arg6 = (*farg6 ? true : false); + arg7 = (*farg7 ? true : false); { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::MatrixMarket::Reader< CMT >::Tpetra_MatrixMarket_Reader_Sl_CMT_Sg__readSparseGraphFile__SWIG_7(std::string const &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > const &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > const &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > const &,bool const,bool const)");; @@ -15134,7 +15134,7 @@ SWIGEXPORT SwigClassWrapper _wrap_TpetraReader_readSparseGraphFile__SWIG_8(SwigA } -SWIGEXPORT SwigClassWrapper _wrap_TpetraReader_readSparseGraphFile__SWIG_9(SwigArrayWrapper *farg1, SwigClassWrapper const *farg2, SwigClassWrapper const *farg3, SwigClassWrapper const *farg4, SwigClassWrapper const *farg5, bool const *farg6) { +SWIGEXPORT SwigClassWrapper _wrap_TpetraReader_readSparseGraphFile__SWIG_9(SwigArrayWrapper *farg1, SwigClassWrapper const *farg2, SwigClassWrapper const *farg3, SwigClassWrapper const *farg4, SwigClassWrapper const *farg5, int const *farg6) { SwigClassWrapper fresult ; std::string *arg1 = 0 ; Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > *arg2 = 0 ; @@ -15155,7 +15155,7 @@ SWIGEXPORT SwigClassWrapper _wrap_TpetraReader_readSparseGraphFile__SWIG_9(SwigA arg3 = farg3->cptr ? static_cast< Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > * >(farg3->cptr) : &tempnull3; arg4 = farg4->cptr ? static_cast< Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > * >(farg4->cptr) : &tempnull4; arg5 = farg5->cptr ? static_cast< Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > * >(farg5->cptr) : &tempnull5; - arg6 = static_cast< bool >(*farg6); + arg6 = (*farg6 ? true : false); { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::MatrixMarket::Reader< CMT >::Tpetra_MatrixMarket_Reader_Sl_CMT_Sg__readSparseGraphFile__SWIG_7(std::string const &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > const &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > const &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > const &,bool const)");; @@ -15234,7 +15234,7 @@ SWIGEXPORT SwigClassWrapper _wrap_TpetraReader_readSparseGraphFile__SWIG_10(Swig } -SWIGEXPORT SwigClassWrapper _wrap_TpetraReader_readSparseFile__SWIG_0(SwigArrayWrapper *farg1, SwigClassWrapper const *farg2, bool const *farg3, bool const *farg4, bool const *farg5) { +SWIGEXPORT SwigClassWrapper _wrap_TpetraReader_readSparseFile__SWIG_0(SwigArrayWrapper *farg1, SwigClassWrapper const *farg2, int const *farg3, int const *farg4, int const *farg5) { SwigClassWrapper fresult ; std::string *arg1 = 0 ; Teuchos::RCP< Teuchos::Comm< int > const > *arg2 = 0 ; @@ -15248,9 +15248,9 @@ SWIGEXPORT SwigClassWrapper _wrap_TpetraReader_readSparseFile__SWIG_0(SwigArrayW tempstr1 = std::string(static_cast(farg1->data), farg1->size); arg1 = &tempstr1; arg2 = farg2->cptr ? static_cast< Teuchos::RCP< Teuchos::Comm< int > const > * >(farg2->cptr) : &tempnull2; - arg3 = static_cast< bool >(*farg3); - arg4 = static_cast< bool >(*farg4); - arg5 = static_cast< bool >(*farg5); + arg3 = (*farg3 ? true : false); + arg4 = (*farg4 ? true : false); + arg5 = (*farg5 ? true : false); { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::MatrixMarket::Reader< CMT >::Tpetra_MatrixMarket_Reader_Sl_CMT_Sg__readSparseFile__SWIG_0(std::string const &,Teuchos::RCP< Teuchos::Comm< int > const > const &,bool const,bool const,bool const)");; @@ -15280,7 +15280,7 @@ SWIGEXPORT SwigClassWrapper _wrap_TpetraReader_readSparseFile__SWIG_0(SwigArrayW } -SWIGEXPORT SwigClassWrapper _wrap_TpetraReader_readSparseFile__SWIG_1(SwigArrayWrapper *farg1, SwigClassWrapper const *farg2, bool const *farg3, bool const *farg4) { +SWIGEXPORT SwigClassWrapper _wrap_TpetraReader_readSparseFile__SWIG_1(SwigArrayWrapper *farg1, SwigClassWrapper const *farg2, int const *farg3, int const *farg4) { SwigClassWrapper fresult ; std::string *arg1 = 0 ; Teuchos::RCP< Teuchos::Comm< int > const > *arg2 = 0 ; @@ -15293,8 +15293,8 @@ SWIGEXPORT SwigClassWrapper _wrap_TpetraReader_readSparseFile__SWIG_1(SwigArrayW tempstr1 = std::string(static_cast(farg1->data), farg1->size); arg1 = &tempstr1; arg2 = farg2->cptr ? static_cast< Teuchos::RCP< Teuchos::Comm< int > const > * >(farg2->cptr) : &tempnull2; - arg3 = static_cast< bool >(*farg3); - arg4 = static_cast< bool >(*farg4); + arg3 = (*farg3 ? true : false); + arg4 = (*farg4 ? true : false); { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::MatrixMarket::Reader< CMT >::Tpetra_MatrixMarket_Reader_Sl_CMT_Sg__readSparseFile__SWIG_0(std::string const &,Teuchos::RCP< Teuchos::Comm< int > const > const &,bool const,bool const)");; @@ -15324,7 +15324,7 @@ SWIGEXPORT SwigClassWrapper _wrap_TpetraReader_readSparseFile__SWIG_1(SwigArrayW } -SWIGEXPORT SwigClassWrapper _wrap_TpetraReader_readSparseFile__SWIG_2(SwigArrayWrapper *farg1, SwigClassWrapper const *farg2, bool const *farg3) { +SWIGEXPORT SwigClassWrapper _wrap_TpetraReader_readSparseFile__SWIG_2(SwigArrayWrapper *farg1, SwigClassWrapper const *farg2, int const *farg3) { SwigClassWrapper fresult ; std::string *arg1 = 0 ; Teuchos::RCP< Teuchos::Comm< int > const > *arg2 = 0 ; @@ -15336,7 +15336,7 @@ SWIGEXPORT SwigClassWrapper _wrap_TpetraReader_readSparseFile__SWIG_2(SwigArrayW tempstr1 = std::string(static_cast(farg1->data), farg1->size); arg1 = &tempstr1; arg2 = farg2->cptr ? static_cast< Teuchos::RCP< Teuchos::Comm< int > const > * >(farg2->cptr) : &tempnull2; - arg3 = static_cast< bool >(*farg3); + arg3 = (*farg3 ? true : false); { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::MatrixMarket::Reader< CMT >::Tpetra_MatrixMarket_Reader_Sl_CMT_Sg__readSparseFile__SWIG_0(std::string const &,Teuchos::RCP< Teuchos::Comm< int > const > const &,bool const)");; @@ -15406,7 +15406,7 @@ SWIGEXPORT SwigClassWrapper _wrap_TpetraReader_readSparseFile__SWIG_3(SwigArrayW } -SWIGEXPORT SwigClassWrapper _wrap_TpetraReader_readSparseFile__SWIG_4(SwigArrayWrapper *farg1, SwigClassWrapper const *farg2, SwigClassWrapper const *farg3, SwigClassWrapper const *farg4, bool const *farg5, bool const *farg6) { +SWIGEXPORT SwigClassWrapper _wrap_TpetraReader_readSparseFile__SWIG_4(SwigArrayWrapper *farg1, SwigClassWrapper const *farg2, SwigClassWrapper const *farg3, SwigClassWrapper const *farg4, int const *farg5, int const *farg6) { SwigClassWrapper fresult ; std::string *arg1 = 0 ; Teuchos::RCP< Teuchos::Comm< int > const > *arg2 = 0 ; @@ -15425,8 +15425,8 @@ SWIGEXPORT SwigClassWrapper _wrap_TpetraReader_readSparseFile__SWIG_4(SwigArrayW arg2 = farg2->cptr ? static_cast< Teuchos::RCP< Teuchos::Comm< int > const > * >(farg2->cptr) : &tempnull2; arg3 = farg3->cptr ? static_cast< Teuchos::RCP< Teuchos::ParameterList > * >(farg3->cptr) : &tempnull3; arg4 = farg4->cptr ? static_cast< Teuchos::RCP< Teuchos::ParameterList > * >(farg4->cptr) : &tempnull4; - arg5 = static_cast< bool >(*farg5); - arg6 = static_cast< bool >(*farg6); + arg5 = (*farg5 ? true : false); + arg6 = (*farg6 ? true : false); { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::MatrixMarket::Reader< CMT >::Tpetra_MatrixMarket_Reader_Sl_CMT_Sg__readSparseFile__SWIG_4(std::string const &,Teuchos::RCP< Teuchos::Comm< int > const > const &,Teuchos::RCP< Teuchos::ParameterList > const &,Teuchos::RCP< Teuchos::ParameterList > const &,bool const,bool const)");; @@ -15456,7 +15456,7 @@ SWIGEXPORT SwigClassWrapper _wrap_TpetraReader_readSparseFile__SWIG_4(SwigArrayW } -SWIGEXPORT SwigClassWrapper _wrap_TpetraReader_readSparseFile__SWIG_5(SwigArrayWrapper *farg1, SwigClassWrapper const *farg2, SwigClassWrapper const *farg3, SwigClassWrapper const *farg4, bool const *farg5) { +SWIGEXPORT SwigClassWrapper _wrap_TpetraReader_readSparseFile__SWIG_5(SwigArrayWrapper *farg1, SwigClassWrapper const *farg2, SwigClassWrapper const *farg3, SwigClassWrapper const *farg4, int const *farg5) { SwigClassWrapper fresult ; std::string *arg1 = 0 ; Teuchos::RCP< Teuchos::Comm< int > const > *arg2 = 0 ; @@ -15474,7 +15474,7 @@ SWIGEXPORT SwigClassWrapper _wrap_TpetraReader_readSparseFile__SWIG_5(SwigArrayW arg2 = farg2->cptr ? static_cast< Teuchos::RCP< Teuchos::Comm< int > const > * >(farg2->cptr) : &tempnull2; arg3 = farg3->cptr ? static_cast< Teuchos::RCP< Teuchos::ParameterList > * >(farg3->cptr) : &tempnull3; arg4 = farg4->cptr ? static_cast< Teuchos::RCP< Teuchos::ParameterList > * >(farg4->cptr) : &tempnull4; - arg5 = static_cast< bool >(*farg5); + arg5 = (*farg5 ? true : false); { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::MatrixMarket::Reader< CMT >::Tpetra_MatrixMarket_Reader_Sl_CMT_Sg__readSparseFile__SWIG_4(std::string const &,Teuchos::RCP< Teuchos::Comm< int > const > const &,Teuchos::RCP< Teuchos::ParameterList > const &,Teuchos::RCP< Teuchos::ParameterList > const &,bool const)");; @@ -15550,7 +15550,7 @@ SWIGEXPORT SwigClassWrapper _wrap_TpetraReader_readSparseFile__SWIG_6(SwigArrayW } -SWIGEXPORT SwigClassWrapper _wrap_TpetraReader_readSparseFile__SWIG_7(SwigArrayWrapper *farg1, SwigClassWrapper const *farg2, SwigClassWrapper const *farg3, SwigClassWrapper const *farg4, SwigClassWrapper const *farg5, bool const *farg6, bool const *farg7, bool const *farg8) { +SWIGEXPORT SwigClassWrapper _wrap_TpetraReader_readSparseFile__SWIG_7(SwigArrayWrapper *farg1, SwigClassWrapper const *farg2, SwigClassWrapper const *farg3, SwigClassWrapper const *farg4, SwigClassWrapper const *farg5, int const *farg6, int const *farg7, int const *farg8) { SwigClassWrapper fresult ; std::string *arg1 = 0 ; Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > *arg2 = 0 ; @@ -15573,9 +15573,9 @@ SWIGEXPORT SwigClassWrapper _wrap_TpetraReader_readSparseFile__SWIG_7(SwigArrayW arg3 = farg3->cptr ? static_cast< Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > * >(farg3->cptr) : &tempnull3; arg4 = farg4->cptr ? static_cast< Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > * >(farg4->cptr) : &tempnull4; arg5 = farg5->cptr ? static_cast< Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > * >(farg5->cptr) : &tempnull5; - arg6 = static_cast< bool >(*farg6); - arg7 = static_cast< bool >(*farg7); - arg8 = static_cast< bool >(*farg8); + arg6 = (*farg6 ? true : false); + arg7 = (*farg7 ? true : false); + arg8 = (*farg8 ? true : false); { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::MatrixMarket::Reader< CMT >::Tpetra_MatrixMarket_Reader_Sl_CMT_Sg__readSparseFile__SWIG_7(std::string const &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > const &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > const &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > const &,bool const,bool const,bool const)");; @@ -15605,7 +15605,7 @@ SWIGEXPORT SwigClassWrapper _wrap_TpetraReader_readSparseFile__SWIG_7(SwigArrayW } -SWIGEXPORT SwigClassWrapper _wrap_TpetraReader_readSparseFile__SWIG_8(SwigArrayWrapper *farg1, SwigClassWrapper const *farg2, SwigClassWrapper const *farg3, SwigClassWrapper const *farg4, SwigClassWrapper const *farg5, bool const *farg6, bool const *farg7) { +SWIGEXPORT SwigClassWrapper _wrap_TpetraReader_readSparseFile__SWIG_8(SwigArrayWrapper *farg1, SwigClassWrapper const *farg2, SwigClassWrapper const *farg3, SwigClassWrapper const *farg4, SwigClassWrapper const *farg5, int const *farg6, int const *farg7) { SwigClassWrapper fresult ; std::string *arg1 = 0 ; Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > *arg2 = 0 ; @@ -15627,8 +15627,8 @@ SWIGEXPORT SwigClassWrapper _wrap_TpetraReader_readSparseFile__SWIG_8(SwigArrayW arg3 = farg3->cptr ? static_cast< Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > * >(farg3->cptr) : &tempnull3; arg4 = farg4->cptr ? static_cast< Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > * >(farg4->cptr) : &tempnull4; arg5 = farg5->cptr ? static_cast< Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > * >(farg5->cptr) : &tempnull5; - arg6 = static_cast< bool >(*farg6); - arg7 = static_cast< bool >(*farg7); + arg6 = (*farg6 ? true : false); + arg7 = (*farg7 ? true : false); { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::MatrixMarket::Reader< CMT >::Tpetra_MatrixMarket_Reader_Sl_CMT_Sg__readSparseFile__SWIG_7(std::string const &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > const &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > const &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > const &,bool const,bool const)");; @@ -15658,7 +15658,7 @@ SWIGEXPORT SwigClassWrapper _wrap_TpetraReader_readSparseFile__SWIG_8(SwigArrayW } -SWIGEXPORT SwigClassWrapper _wrap_TpetraReader_readSparseFile__SWIG_9(SwigArrayWrapper *farg1, SwigClassWrapper const *farg2, SwigClassWrapper const *farg3, SwigClassWrapper const *farg4, SwigClassWrapper const *farg5, bool const *farg6) { +SWIGEXPORT SwigClassWrapper _wrap_TpetraReader_readSparseFile__SWIG_9(SwigArrayWrapper *farg1, SwigClassWrapper const *farg2, SwigClassWrapper const *farg3, SwigClassWrapper const *farg4, SwigClassWrapper const *farg5, int const *farg6) { SwigClassWrapper fresult ; std::string *arg1 = 0 ; Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > *arg2 = 0 ; @@ -15679,7 +15679,7 @@ SWIGEXPORT SwigClassWrapper _wrap_TpetraReader_readSparseFile__SWIG_9(SwigArrayW arg3 = farg3->cptr ? static_cast< Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > * >(farg3->cptr) : &tempnull3; arg4 = farg4->cptr ? static_cast< Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > * >(farg4->cptr) : &tempnull4; arg5 = farg5->cptr ? static_cast< Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > * >(farg5->cptr) : &tempnull5; - arg6 = static_cast< bool >(*farg6); + arg6 = (*farg6 ? true : false); { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::MatrixMarket::Reader< CMT >::Tpetra_MatrixMarket_Reader_Sl_CMT_Sg__readSparseFile__SWIG_7(std::string const &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > const &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > const &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > const &,bool const)");; @@ -15758,7 +15758,7 @@ SWIGEXPORT SwigClassWrapper _wrap_TpetraReader_readSparseFile__SWIG_10(SwigArray } -SWIGEXPORT SwigClassWrapper _wrap_TpetraReader_readDenseFile__SWIG_0(SwigArrayWrapper *farg1, SwigClassWrapper const *farg2, SwigClassWrapper const *farg3, bool const *farg4, bool const *farg5) { +SWIGEXPORT SwigClassWrapper _wrap_TpetraReader_readDenseFile__SWIG_0(SwigArrayWrapper *farg1, SwigClassWrapper const *farg2, SwigClassWrapper const *farg3, int const *farg4, int const *farg5) { SwigClassWrapper fresult ; std::string *arg1 = 0 ; Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::comm_type const > *arg2 = 0 ; @@ -15774,8 +15774,8 @@ SWIGEXPORT SwigClassWrapper _wrap_TpetraReader_readDenseFile__SWIG_0(SwigArrayWr arg1 = &tempstr1; arg2 = farg2->cptr ? static_cast< Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::comm_type const > * >(farg2->cptr) : &tempnull2; arg3 = farg3->cptr ? static_cast< Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > * >(farg3->cptr) : &tempnull3; - arg4 = static_cast< bool >(*farg4); - arg5 = static_cast< bool >(*farg5); + arg4 = (*farg4 ? true : false); + arg5 = (*farg5 ? true : false); { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::MatrixMarket::Reader< CMT >::Tpetra_MatrixMarket_Reader_Sl_CMT_Sg__readDenseFile__SWIG_0(std::string const &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::comm_type const > const &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > &,bool const,bool const)");; @@ -15805,7 +15805,7 @@ SWIGEXPORT SwigClassWrapper _wrap_TpetraReader_readDenseFile__SWIG_0(SwigArrayWr } -SWIGEXPORT SwigClassWrapper _wrap_TpetraReader_readDenseFile__SWIG_1(SwigArrayWrapper *farg1, SwigClassWrapper const *farg2, SwigClassWrapper const *farg3, bool const *farg4) { +SWIGEXPORT SwigClassWrapper _wrap_TpetraReader_readDenseFile__SWIG_1(SwigArrayWrapper *farg1, SwigClassWrapper const *farg2, SwigClassWrapper const *farg3, int const *farg4) { SwigClassWrapper fresult ; std::string *arg1 = 0 ; Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::comm_type const > *arg2 = 0 ; @@ -15820,7 +15820,7 @@ SWIGEXPORT SwigClassWrapper _wrap_TpetraReader_readDenseFile__SWIG_1(SwigArrayWr arg1 = &tempstr1; arg2 = farg2->cptr ? static_cast< Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::comm_type const > * >(farg2->cptr) : &tempnull2; arg3 = farg3->cptr ? static_cast< Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > * >(farg3->cptr) : &tempnull3; - arg4 = static_cast< bool >(*farg4); + arg4 = (*farg4 ? true : false); { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::MatrixMarket::Reader< CMT >::Tpetra_MatrixMarket_Reader_Sl_CMT_Sg__readDenseFile__SWIG_0(std::string const &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::comm_type const > const &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > &,bool const)");; @@ -15893,7 +15893,7 @@ SWIGEXPORT SwigClassWrapper _wrap_TpetraReader_readDenseFile__SWIG_2(SwigArrayWr } -SWIGEXPORT SwigClassWrapper _wrap_TpetraReader_readMapFile__SWIG_0(SwigArrayWrapper *farg1, SwigClassWrapper const *farg2, bool const *farg3, bool const *farg4) { +SWIGEXPORT SwigClassWrapper _wrap_TpetraReader_readMapFile__SWIG_0(SwigArrayWrapper *farg1, SwigClassWrapper const *farg2, int const *farg3, int const *farg4) { SwigClassWrapper fresult ; std::string *arg1 = 0 ; Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::comm_type const > *arg2 = 0 ; @@ -15906,8 +15906,8 @@ SWIGEXPORT SwigClassWrapper _wrap_TpetraReader_readMapFile__SWIG_0(SwigArrayWrap tempstr1 = std::string(static_cast(farg1->data), farg1->size); arg1 = &tempstr1; arg2 = farg2->cptr ? static_cast< Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::comm_type const > * >(farg2->cptr) : &tempnull2; - arg3 = static_cast< bool >(*farg3); - arg4 = static_cast< bool >(*farg4); + arg3 = (*farg3 ? true : false); + arg4 = (*farg4 ? true : false); { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::MatrixMarket::Reader< CMT >::Tpetra_MatrixMarket_Reader_Sl_CMT_Sg__readMapFile__SWIG_0(std::string const &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::comm_type const > const &,bool const,bool const)");; @@ -15937,7 +15937,7 @@ SWIGEXPORT SwigClassWrapper _wrap_TpetraReader_readMapFile__SWIG_0(SwigArrayWrap } -SWIGEXPORT SwigClassWrapper _wrap_TpetraReader_readMapFile__SWIG_1(SwigArrayWrapper *farg1, SwigClassWrapper const *farg2, bool const *farg3) { +SWIGEXPORT SwigClassWrapper _wrap_TpetraReader_readMapFile__SWIG_1(SwigArrayWrapper *farg1, SwigClassWrapper const *farg2, int const *farg3) { SwigClassWrapper fresult ; std::string *arg1 = 0 ; Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::comm_type const > *arg2 = 0 ; @@ -15949,7 +15949,7 @@ SWIGEXPORT SwigClassWrapper _wrap_TpetraReader_readMapFile__SWIG_1(SwigArrayWrap tempstr1 = std::string(static_cast(farg1->data), farg1->size); arg1 = &tempstr1; arg2 = farg2->cptr ? static_cast< Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::comm_type const > * >(farg2->cptr) : &tempnull2; - arg3 = static_cast< bool >(*farg3); + arg3 = (*farg3 ? true : false); { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::MatrixMarket::Reader< CMT >::Tpetra_MatrixMarket_Reader_Sl_CMT_Sg__readMapFile__SWIG_0(std::string const &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::comm_type const > const &,bool const)");; @@ -16131,7 +16131,7 @@ SWIGEXPORT void _wrap_TpetraWriter_writeMapFile(SwigArrayWrapper *farg1, SwigCla } -SWIGEXPORT void _wrap_TpetraWriter_writeSparseFile__SWIG_0(SwigArrayWrapper *farg1, SwigClassWrapper const *farg2, SwigArrayWrapper *farg3, SwigArrayWrapper *farg4, bool const *farg5) { +SWIGEXPORT void _wrap_TpetraWriter_writeSparseFile__SWIG_0(SwigArrayWrapper *farg1, SwigClassWrapper const *farg2, SwigArrayWrapper *farg3, SwigArrayWrapper *farg4, int const *farg5) { std::string *arg1 = 0 ; Teuchos::RCP< Tpetra::MatrixMarket::Writer< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > >::sparse_matrix_type const > *arg2 = 0 ; std::string *arg3 = 0 ; @@ -16149,7 +16149,7 @@ SWIGEXPORT void _wrap_TpetraWriter_writeSparseFile__SWIG_0(SwigArrayWrapper *far arg3 = &tempstr3; tempstr4 = std::string(static_cast(farg4->data), farg4->size); arg4 = &tempstr4; - arg5 = static_cast< bool >(*farg5); + arg5 = (*farg5 ? true : false); { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::MatrixMarket::Writer< CMT >::Tpetra_MatrixMarket_Writer_Sl_CMT_Sg__writeSparseFile__SWIG_0(std::string const &,Teuchos::RCP< Tpetra::MatrixMarket::Writer< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > >::sparse_matrix_type const > const &,std::string const &,std::string const &,bool const)");; @@ -16221,7 +16221,7 @@ SWIGEXPORT void _wrap_TpetraWriter_writeSparseFile__SWIG_1(SwigArrayWrapper *far } -SWIGEXPORT void _wrap_TpetraWriter_writeSparseFile__SWIG_2(SwigArrayWrapper *farg1, SwigClassWrapper const *farg2, bool const *farg3) { +SWIGEXPORT void _wrap_TpetraWriter_writeSparseFile__SWIG_2(SwigArrayWrapper *farg1, SwigClassWrapper const *farg2, int const *farg3) { std::string *arg1 = 0 ; Teuchos::RCP< Tpetra::MatrixMarket::Writer< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > >::sparse_matrix_type const > *arg2 = 0 ; bool arg3 ; @@ -16231,7 +16231,7 @@ SWIGEXPORT void _wrap_TpetraWriter_writeSparseFile__SWIG_2(SwigArrayWrapper *far tempstr1 = std::string(static_cast(farg1->data), farg1->size); arg1 = &tempstr1; arg2 = farg2->cptr ? static_cast< Teuchos::RCP< Tpetra::MatrixMarket::Writer< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > >::sparse_matrix_type const > * >(farg2->cptr) : &tempnull2; - arg3 = static_cast< bool >(*farg3); + arg3 = (*farg3 ? true : false); { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::MatrixMarket::Writer< CMT >::Tpetra_MatrixMarket_Writer_Sl_CMT_Sg__writeSparseFile__SWIG_2(std::string const &,Teuchos::RCP< Tpetra::MatrixMarket::Writer< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > >::sparse_matrix_type const > const &,bool const)");; @@ -16295,7 +16295,7 @@ SWIGEXPORT void _wrap_TpetraWriter_writeSparseFile__SWIG_3(SwigArrayWrapper *far } -SWIGEXPORT void _wrap_TpetraWriter_writeSparseGraphFile__SWIG_0(SwigArrayWrapper *farg1, SwigClassWrapper const *farg2, SwigArrayWrapper *farg3, SwigArrayWrapper *farg4, bool const *farg5) { +SWIGEXPORT void _wrap_TpetraWriter_writeSparseGraphFile__SWIG_0(SwigArrayWrapper *farg1, SwigClassWrapper const *farg2, SwigArrayWrapper *farg3, SwigArrayWrapper *farg4, int const *farg5) { std::string *arg1 = 0 ; Teuchos::RCP< Tpetra::MatrixMarket::Writer< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > >::crs_graph_type const > *arg2 = 0 ; std::string *arg3 = 0 ; @@ -16313,7 +16313,7 @@ SWIGEXPORT void _wrap_TpetraWriter_writeSparseGraphFile__SWIG_0(SwigArrayWrapper arg3 = &tempstr3; tempstr4 = std::string(static_cast(farg4->data), farg4->size); arg4 = &tempstr4; - arg5 = static_cast< bool >(*farg5); + arg5 = (*farg5 ? true : false); { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::MatrixMarket::Writer< CMT >::Tpetra_MatrixMarket_Writer_Sl_CMT_Sg__writeSparseGraphFile__SWIG_0(std::string const &,Teuchos::RCP< Tpetra::MatrixMarket::Writer< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > >::crs_graph_type const > const &,std::string const &,std::string const &,bool const)");; @@ -16385,7 +16385,7 @@ SWIGEXPORT void _wrap_TpetraWriter_writeSparseGraphFile__SWIG_1(SwigArrayWrapper } -SWIGEXPORT void _wrap_TpetraWriter_writeSparseGraphFile__SWIG_2(SwigArrayWrapper *farg1, SwigClassWrapper const *farg2, bool const *farg3) { +SWIGEXPORT void _wrap_TpetraWriter_writeSparseGraphFile__SWIG_2(SwigArrayWrapper *farg1, SwigClassWrapper const *farg2, int const *farg3) { std::string *arg1 = 0 ; Teuchos::RCP< Tpetra::MatrixMarket::Writer< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > >::crs_graph_type const > *arg2 = 0 ; bool arg3 ; @@ -16395,7 +16395,7 @@ SWIGEXPORT void _wrap_TpetraWriter_writeSparseGraphFile__SWIG_2(SwigArrayWrapper tempstr1 = std::string(static_cast(farg1->data), farg1->size); arg1 = &tempstr1; arg2 = farg2->cptr ? static_cast< Teuchos::RCP< Tpetra::MatrixMarket::Writer< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > >::crs_graph_type const > * >(farg2->cptr) : &tempnull2; - arg3 = static_cast< bool >(*farg3); + arg3 = (*farg3 ? true : false); { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::MatrixMarket::Writer< CMT >::Tpetra_MatrixMarket_Writer_Sl_CMT_Sg__writeSparseGraphFile__SWIG_2(std::string const &,Teuchos::RCP< Tpetra::MatrixMarket::Writer< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > >::crs_graph_type const > const &,bool const)");; @@ -16613,7 +16613,7 @@ SWIGEXPORT void _wrap_assign_TpetraWriter(SwigClassWrapper * self, SwigClassWrap } -SWIGEXPORT void _wrap_TpetraMatrixMatrixMultiply__SWIG_0(SwigClassWrapper const *farg1, bool const *farg2, SwigClassWrapper const *farg3, bool const *farg4, SwigClassWrapper const *farg5, bool const *farg6, SwigArrayWrapper *farg7, SwigClassWrapper const *farg8) { +SWIGEXPORT void _wrap_TpetraMatrixMatrixMultiply__SWIG_0(SwigClassWrapper const *farg1, int const *farg2, SwigClassWrapper const *farg3, int const *farg4, SwigClassWrapper const *farg5, int const *farg6, SwigArrayWrapper *farg7, SwigClassWrapper const *farg8) { Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > *arg1 = 0 ; bool arg2 ; Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > *arg3 = 0 ; @@ -16631,15 +16631,15 @@ SWIGEXPORT void _wrap_TpetraMatrixMatrixMultiply__SWIG_0(SwigClassWrapper const SWIG_check_sp_nonnull(farg1, "Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > *", "TpetraCrsMatrix", "Tpetra::MatrixMatrix::Multiply< SC,LO,GO,NO >(Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &,bool,Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &,bool,Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > &,bool,std::string const &,Teuchos::RCP< Teuchos::ParameterList > const &)", return ) smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); arg1 = const_cast< Tpetra::CrsMatrix* >(smartarg1->get()); - arg2 = static_cast< bool >(*farg2); + arg2 = (*farg2 ? true : false); SWIG_check_sp_nonnull(farg3, "Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > *", "TpetraCrsMatrix", "Tpetra::MatrixMatrix::Multiply< SC,LO,GO,NO >(Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &,bool,Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &,bool,Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > &,bool,std::string const &,Teuchos::RCP< Teuchos::ParameterList > const &)", return ) smartarg3 = static_cast< Teuchos::RCP >* >(farg3->cptr); arg3 = const_cast< Tpetra::CrsMatrix* >(smartarg3->get()); - arg4 = static_cast< bool >(*farg4); + arg4 = (*farg4 ? true : false); SWIG_check_sp_nonnull(farg5, "Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > *", "TpetraCrsMatrix", "Tpetra::MatrixMatrix::Multiply< SC,LO,GO,NO >(Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &,bool,Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &,bool,Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > &,bool,std::string const &,Teuchos::RCP< Teuchos::ParameterList > const &)", return ) smartarg5 = static_cast< Teuchos::RCP< Tpetra::CrsMatrix >* >(farg5->cptr); arg5 = const_cast< Tpetra::CrsMatrix* >(smartarg5->get()); - arg6 = static_cast< bool >(*farg6); + arg6 = (*farg6 ? true : false); tempstr7 = std::string(static_cast(farg7->data), farg7->size); arg7 = &tempstr7; arg8 = farg8->cptr ? static_cast< Teuchos::RCP< Teuchos::ParameterList > * >(farg8->cptr) : &tempnull8; @@ -16670,7 +16670,7 @@ SWIGEXPORT void _wrap_TpetraMatrixMatrixMultiply__SWIG_0(SwigClassWrapper const } -SWIGEXPORT void _wrap_TpetraMatrixMatrixMultiply__SWIG_1(SwigClassWrapper const *farg1, bool const *farg2, SwigClassWrapper const *farg3, bool const *farg4, SwigClassWrapper const *farg5, bool const *farg6, SwigArrayWrapper *farg7) { +SWIGEXPORT void _wrap_TpetraMatrixMatrixMultiply__SWIG_1(SwigClassWrapper const *farg1, int const *farg2, SwigClassWrapper const *farg3, int const *farg4, SwigClassWrapper const *farg5, int const *farg6, SwigArrayWrapper *farg7) { Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > *arg1 = 0 ; bool arg2 ; Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > *arg3 = 0 ; @@ -16686,15 +16686,15 @@ SWIGEXPORT void _wrap_TpetraMatrixMatrixMultiply__SWIG_1(SwigClassWrapper const SWIG_check_sp_nonnull(farg1, "Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > *", "TpetraCrsMatrix", "Tpetra::MatrixMatrix::Multiply< SC,LO,GO,NO >(Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &,bool,Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &,bool,Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > &,bool,std::string const &)", return ) smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); arg1 = const_cast< Tpetra::CrsMatrix* >(smartarg1->get()); - arg2 = static_cast< bool >(*farg2); + arg2 = (*farg2 ? true : false); SWIG_check_sp_nonnull(farg3, "Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > *", "TpetraCrsMatrix", "Tpetra::MatrixMatrix::Multiply< SC,LO,GO,NO >(Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &,bool,Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &,bool,Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > &,bool,std::string const &)", return ) smartarg3 = static_cast< Teuchos::RCP >* >(farg3->cptr); arg3 = const_cast< Tpetra::CrsMatrix* >(smartarg3->get()); - arg4 = static_cast< bool >(*farg4); + arg4 = (*farg4 ? true : false); SWIG_check_sp_nonnull(farg5, "Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > *", "TpetraCrsMatrix", "Tpetra::MatrixMatrix::Multiply< SC,LO,GO,NO >(Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &,bool,Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &,bool,Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > &,bool,std::string const &)", return ) smartarg5 = static_cast< Teuchos::RCP< Tpetra::CrsMatrix >* >(farg5->cptr); arg5 = const_cast< Tpetra::CrsMatrix* >(smartarg5->get()); - arg6 = static_cast< bool >(*farg6); + arg6 = (*farg6 ? true : false); tempstr7 = std::string(static_cast(farg7->data), farg7->size); arg7 = &tempstr7; { @@ -16724,7 +16724,7 @@ SWIGEXPORT void _wrap_TpetraMatrixMatrixMultiply__SWIG_1(SwigClassWrapper const } -SWIGEXPORT void _wrap_TpetraMatrixMatrixMultiply__SWIG_2(SwigClassWrapper const *farg1, bool const *farg2, SwigClassWrapper const *farg3, bool const *farg4, SwigClassWrapper const *farg5, bool const *farg6) { +SWIGEXPORT void _wrap_TpetraMatrixMatrixMultiply__SWIG_2(SwigClassWrapper const *farg1, int const *farg2, SwigClassWrapper const *farg3, int const *farg4, SwigClassWrapper const *farg5, int const *farg6) { Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > *arg1 = 0 ; bool arg2 ; Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > *arg3 = 0 ; @@ -16738,15 +16738,15 @@ SWIGEXPORT void _wrap_TpetraMatrixMatrixMultiply__SWIG_2(SwigClassWrapper const SWIG_check_sp_nonnull(farg1, "Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > *", "TpetraCrsMatrix", "Tpetra::MatrixMatrix::Multiply< SC,LO,GO,NO >(Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &,bool,Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &,bool,Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > &,bool)", return ) smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); arg1 = const_cast< Tpetra::CrsMatrix* >(smartarg1->get()); - arg2 = static_cast< bool >(*farg2); + arg2 = (*farg2 ? true : false); SWIG_check_sp_nonnull(farg3, "Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > *", "TpetraCrsMatrix", "Tpetra::MatrixMatrix::Multiply< SC,LO,GO,NO >(Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &,bool,Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &,bool,Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > &,bool)", return ) smartarg3 = static_cast< Teuchos::RCP >* >(farg3->cptr); arg3 = const_cast< Tpetra::CrsMatrix* >(smartarg3->get()); - arg4 = static_cast< bool >(*farg4); + arg4 = (*farg4 ? true : false); SWIG_check_sp_nonnull(farg5, "Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > *", "TpetraCrsMatrix", "Tpetra::MatrixMatrix::Multiply< SC,LO,GO,NO >(Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &,bool,Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &,bool,Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > &,bool)", return ) smartarg5 = static_cast< Teuchos::RCP< Tpetra::CrsMatrix >* >(farg5->cptr); arg5 = const_cast< Tpetra::CrsMatrix* >(smartarg5->get()); - arg6 = static_cast< bool >(*farg6); + arg6 = (*farg6 ? true : false); { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::MatrixMatrix::Multiply< SC,LO,GO,NO >(Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &,bool,Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &,bool,Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > &,bool)");; @@ -16774,7 +16774,7 @@ SWIGEXPORT void _wrap_TpetraMatrixMatrixMultiply__SWIG_2(SwigClassWrapper const } -SWIGEXPORT void _wrap_TpetraMatrixMatrixMultiply__SWIG_3(SwigClassWrapper const *farg1, bool const *farg2, SwigClassWrapper const *farg3, bool const *farg4, SwigClassWrapper const *farg5) { +SWIGEXPORT void _wrap_TpetraMatrixMatrixMultiply__SWIG_3(SwigClassWrapper const *farg1, int const *farg2, SwigClassWrapper const *farg3, int const *farg4, SwigClassWrapper const *farg5) { Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > *arg1 = 0 ; bool arg2 ; Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > *arg3 = 0 ; @@ -16787,11 +16787,11 @@ SWIGEXPORT void _wrap_TpetraMatrixMatrixMultiply__SWIG_3(SwigClassWrapper const SWIG_check_sp_nonnull(farg1, "Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > *", "TpetraCrsMatrix", "Tpetra::MatrixMatrix::Multiply< SC,LO,GO,NO >(Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &,bool,Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &,bool,Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > &)", return ) smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); arg1 = const_cast< Tpetra::CrsMatrix* >(smartarg1->get()); - arg2 = static_cast< bool >(*farg2); + arg2 = (*farg2 ? true : false); SWIG_check_sp_nonnull(farg3, "Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > *", "TpetraCrsMatrix", "Tpetra::MatrixMatrix::Multiply< SC,LO,GO,NO >(Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &,bool,Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &,bool,Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > &)", return ) smartarg3 = static_cast< Teuchos::RCP >* >(farg3->cptr); arg3 = const_cast< Tpetra::CrsMatrix* >(smartarg3->get()); - arg4 = static_cast< bool >(*farg4); + arg4 = (*farg4 ? true : false); SWIG_check_sp_nonnull(farg5, "Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > *", "TpetraCrsMatrix", "Tpetra::MatrixMatrix::Multiply< SC,LO,GO,NO >(Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &,bool,Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &,bool,Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > &)", return ) smartarg5 = static_cast< Teuchos::RCP< Tpetra::CrsMatrix >* >(farg5->cptr); arg5 = const_cast< Tpetra::CrsMatrix* >(smartarg5->get()); @@ -16822,7 +16822,7 @@ SWIGEXPORT void _wrap_TpetraMatrixMatrixMultiply__SWIG_3(SwigClassWrapper const } -SWIGEXPORT void _wrap_TpetraMatrixMatrixAdd__SWIG_0(SwigClassWrapper const *farg1, bool const *farg2, double const *farg3, SwigClassWrapper const *farg4, double const *farg5) { +SWIGEXPORT void _wrap_TpetraMatrixMatrixAdd__SWIG_0(SwigClassWrapper const *farg1, int const *farg2, double const *farg3, SwigClassWrapper const *farg4, double const *farg5) { Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > *arg1 = 0 ; bool arg2 ; double arg3 ; @@ -16834,7 +16834,7 @@ SWIGEXPORT void _wrap_TpetraMatrixMatrixAdd__SWIG_0(SwigClassWrapper const *farg SWIG_check_sp_nonnull(farg1, "Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > *", "TpetraCrsMatrix", "Tpetra::MatrixMatrix::Add< SC,LO,GO,NO >(Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &,bool,double,Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > &,double)", return ) smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); arg1 = const_cast< Tpetra::CrsMatrix* >(smartarg1->get()); - arg2 = static_cast< bool >(*farg2); + arg2 = (*farg2 ? true : false); arg3 = static_cast< double >(*farg3); SWIG_check_sp_nonnull(farg4, "Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > *", "TpetraCrsMatrix", "Tpetra::MatrixMatrix::Add< SC,LO,GO,NO >(Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &,bool,double,Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > &,double)", return ) smartarg4 = static_cast< Teuchos::RCP< Tpetra::CrsMatrix >* >(farg4->cptr); @@ -16867,7 +16867,7 @@ SWIGEXPORT void _wrap_TpetraMatrixMatrixAdd__SWIG_0(SwigClassWrapper const *farg } -SWIGEXPORT void _wrap_TpetraMatrixMatrixAdd__SWIG_1(SwigClassWrapper const *farg1, bool const *farg2, double const *farg3, SwigClassWrapper const *farg4, bool const *farg5, double const *farg6, SwigClassWrapper const *farg7) { +SWIGEXPORT void _wrap_TpetraMatrixMatrixAdd__SWIG_1(SwigClassWrapper const *farg1, int const *farg2, double const *farg3, SwigClassWrapper const *farg4, int const *farg5, double const *farg6, SwigClassWrapper const *farg7) { Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > *arg1 = 0 ; bool arg2 ; double arg3 ; @@ -16881,12 +16881,12 @@ SWIGEXPORT void _wrap_TpetraMatrixMatrixAdd__SWIG_1(SwigClassWrapper const *farg SWIG_check_sp_nonnull(farg1, "Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > *", "TpetraCrsMatrix", "Tpetra::MatrixMatrix::Add< SC,LO,GO,NO >(Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &,bool,double,Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &,bool,double,Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > >)", return ) smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); arg1 = const_cast< Tpetra::CrsMatrix* >(smartarg1->get()); - arg2 = static_cast< bool >(*farg2); + arg2 = (*farg2 ? true : false); arg3 = static_cast< double >(*farg3); SWIG_check_sp_nonnull(farg4, "Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > *", "TpetraCrsMatrix", "Tpetra::MatrixMatrix::Add< SC,LO,GO,NO >(Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &,bool,double,Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &,bool,double,Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > >)", return ) smartarg4 = static_cast< Teuchos::RCP >* >(farg4->cptr); arg4 = const_cast< Tpetra::CrsMatrix* >(smartarg4->get()); - arg5 = static_cast< bool >(*farg5); + arg5 = (*farg5 ? true : false); arg6 = static_cast< double >(*farg6); if (farg7->cptr) arg7 = *static_cast< Teuchos::RCP< Tpetra::CrsMatrix >* >(farg7->cptr); { diff --git a/src/tpetra/test/test_tpetra_crsgraph.f90 b/src/tpetra/test/test_tpetra_crsgraph.f90 index 5b61bb5b..e623fb76 100644 --- a/src/tpetra/test/test_tpetra_crsgraph.f90 +++ b/src/tpetra/test/test_tpetra_crsgraph.f90 @@ -64,7 +64,6 @@ program test_TpetraCrsGraph type(TpetraCrsGraph) :: Graph integer(local_ordinal_type) :: row, indices(1) integer(size_type), parameter :: izero=0, ione=1 - logical(c_bool), parameter :: false=.false. OUT0("Starting TpetraCrsGraph_ActiveFillLocal!") @@ -80,7 +79,7 @@ program test_TpetraCrsGraph indices(1) = 1 call Graph%insertLocalIndices(row, indices) - call params%set("Optimize Storage", false) + call params%set("Optimize Storage", .false.) call graph%fillComplete(params) TEST_ASSERT((.not. graph%isFillActive())) @@ -101,7 +100,7 @@ program test_TpetraCrsGraph row = 1 indices(1) = 1 call Graph%insertLocalIndices(row, indices) - call params%set("Optimize Storage", false) + call params%set("Optimize Storage", .false.) call Graph%fillComplete(params); TEST_ASSERT((.not. graph%isFillActive())) TEST_ASSERT(graph%isFillComplete()) @@ -163,7 +162,6 @@ program test_TpetraCrsGraph integer(local_ordinal_type) :: lclrow integer(global_ordinal_type) :: myrowind integer(global_ordinal_type), allocatable :: indices(:) - logical(c_bool), parameter :: true=.true., false=.false. integer(size_type), parameter :: ione=1 OUT0("Starting TpetraCrsGraph_WithColMap!") @@ -222,7 +220,6 @@ program test_TpetraCrsGraph integer(size_type), allocatable :: rowptr(:) integer(local_ordinal_type), allocatable :: colind(:) integer(global_ordinal_type), allocatable :: indices(:) - logical(c_bool), parameter :: false=.false., true=.true. OUT0("Starting TpetraCrsGraph_TwoArraysESFC!") @@ -268,7 +265,6 @@ program test_TpetraCrsGraph integer(size_type), allocatable :: rowptr(:) integer(local_ordinal_type), allocatable :: colind(:) integer(global_ordinal_type), allocatable :: indices(:) - logical(c_bool), parameter :: false=.false., true=.true. integer(size_type), parameter :: izero=0 OUT0("Starting TpetraCrsGraph_SetAllIndices!") @@ -313,8 +309,7 @@ program test_TpetraCrsGraph type(ParameterList) :: params integer(size_type) :: num_procs, num_local, nument integer(size_type), allocatable :: rowptr(:) - logical(c_bool), parameter :: false=.false., true=.true. - logical(c_bool) :: sorting_check + logical :: sorting_check integer(size_type), parameter :: izero=0 integer(global_ordinal_type) :: j, jj, jstart, jfinish, firstind, lastind integer(global_ordinal_type), allocatable :: jinds(:) @@ -353,10 +348,10 @@ program test_TpetraCrsGraph ! fill complete; should be sorted now params = ParameterList("ANONYMOUS") - call params%set("Optimize Storage", false) + call params%set("Optimize Storage", .false.) call graph%fillComplete(params) - sorting_check = true + sorting_check = .true. kstart = map%getMinLocalIndex() kfinish = map%getMaxLocalIndex() do k = kstart, kfinish @@ -365,7 +360,7 @@ program test_TpetraCrsGraph call Graph%getLocalRowCopy(k, kinds, nument); do kk = 2, nument if (kinds(kk-1) > kinds(kk)) then - sorting_check = false + sorting_check = .false. exit endif end do @@ -377,7 +372,7 @@ program test_TpetraCrsGraph call Graph%resumeFill() TEST_ASSERT(graph%isSorted()) - sorting_check = true + sorting_check = .true. kstart = map%getMinLocalIndex() kfinish = map%getMaxLocalIndex() do k = kstart, kfinish @@ -386,7 +381,7 @@ program test_TpetraCrsGraph call Graph%getLocalRowCopy(k, kinds, nument); do kk = 2, nument if (kinds(kk-1) > kinds(kk)) then - sorting_check = false + sorting_check = .false. exit endif end do @@ -404,10 +399,10 @@ program test_TpetraCrsGraph deallocate(kinds) ! fill complete, check one more time - call params%set("Optimize Storage", false) + call params%set("Optimize Storage", .false.) call graph%fillComplete(params) - sorting_check = true + sorting_check = .true. kstart = map%getMinLocalIndex() kfinish = map%getMaxLocalIndex() do k = kstart, kfinish @@ -416,7 +411,7 @@ program test_TpetraCrsGraph call Graph%getLocalRowCopy(k, kinds, nument); do kk = 2, nument if (kinds(kk-1) > kinds(kk)) then - sorting_check = false + sorting_check = .false. exit endif end do @@ -470,7 +465,6 @@ program test_TpetraCrsGraph integer(local_ordinal_type) :: lclrow integer(global_ordinal_type) :: myrowind integer(global_ordinal_type), allocatable :: indices(:) - logical(c_bool), parameter :: true=.true. integer(local_ordinal_type) :: i_LO, commsize integer(local_ordinal_type), parameter :: ione=1 diff --git a/src/tpetra/test/test_tpetra_crsmatrix.f90 b/src/tpetra/test/test_tpetra_crsmatrix.f90 index 9355860d..d6a925ea 100644 --- a/src/tpetra/test/test_tpetra_crsmatrix.f90 +++ b/src/tpetra/test/test_tpetra_crsmatrix.f90 @@ -55,7 +55,6 @@ program test_TpetraCrsMatrix type(TpetraCrsMatrix) :: Mat type(TpetraMultiVector) :: mvrand, mvres character(kind=C_CHAR, len=:), allocatable :: description - logical(c_bool), parameter :: false=.false., true=.true. integer(size_type) :: num_images, my_image_id integer(size_type), parameter :: num_local=10, num_vecs=5 integer(size_type), parameter :: ione=1 @@ -75,8 +74,8 @@ program test_TpetraCrsMatrix ! create a Map map = TpetraMap(TPETRA_GLOBAL_INVALID, num_local, comm); TEST_IERR() - mvrand = TpetraMultiVector(Map, num_vecs, false); TEST_IERR() - mvres = TpetraMultiVector(Map, num_vecs, false); TEST_IERR() + mvrand = TpetraMultiVector(Map, num_vecs, .false.); TEST_IERR() + mvres = TpetraMultiVector(Map, num_vecs, .false.); TEST_IERR() call mvrand%randomize(); TEST_IERR() ! create the identity matrix @@ -191,7 +190,6 @@ program test_TpetraCrsMatrix integer(size_type), parameter :: izero=0, ione=1, ithree=3 integer(size_type) :: num_images, my_image_id, numindices integer(local_ordinal_type) :: nnz - logical(c_bool), parameter :: false=.false., true=.true. real(scalar_type), parameter :: zero=0., one=1., two=2., negthree=-3. real(norm_type) :: norms(1) integer(global_ordinal_type) :: gblrow @@ -208,8 +206,8 @@ program test_TpetraCrsMatrix map = TpetraMap(TPETRA_GLOBAL_INVALID, ione, comm); TEST_IERR() ! create a multivector ones(n,1) - ones = TpetraMultiVector(map, ione, false); TEST_IERR() - threes = TpetraMultiVector(map, ione, false); TEST_IERR() + ones = TpetraMultiVector(map, ione, .false.); TEST_IERR() + threes = TpetraMultiVector(map, ione, .false.); TEST_IERR() call ones%putScalar(one) ! create the following matrix: @@ -359,7 +357,6 @@ program test_TpetraCrsMatrix type(ParameterList) :: params type(TpetraCrsMatrix) :: Mat integer(size_type), parameter :: izero=0, ione=1 - logical(c_bool), parameter :: true=.true., false=.false. integer(local_ordinal_type) :: lclrow, numvalid integer(global_ordinal_type) :: row, cols(1) real(scalar_type), parameter :: zero=0. @@ -379,7 +376,7 @@ program test_TpetraCrsMatrix call Mat%insertGlobalValues(row, cols, zeros); TEST_IERR() params = ParameterList("ANONOMOUS") - ! call params%set("Optimize Storage", false) ! FIXME: boolean parameters + ! call params%set("Optimize Storage", .false.) ! FIXME: boolean parameters call Mat%fillComplete(params); TEST_ASSERT((.not. Mat%isFillActive())) TEST_ASSERT(Mat%isFillComplete()) @@ -453,7 +450,6 @@ program test_TpetraCrsMatrix type(ParameterList) :: params type(TpetraCrsMatrix) :: Mat integer(size_type), parameter :: izero=0, ione=1 - logical(c_bool), parameter :: true=.true., false=.false. integer(local_ordinal_type) :: row, cols(1), numvalid real(scalar_type), parameter :: zero=0. real(scalar_type) :: vals(1), zeros(1)=[zero] @@ -470,7 +466,7 @@ program test_TpetraCrsMatrix call Mat%insertLocalValues(row, cols, tuple(0)); TEST_IERR() params = ParameterList("ANONOMOUS") - ! call params%set("Optimize Storage", false) ! FIXME: boolean parameters + ! call params%set("Optimize Storage", .false.) ! FIXME: boolean parameters call Mat%fillComplete(params); TEST_ASSERT((.not. Mat%isFillActive())) TEST_ASSERT(Mat%isFillComplete()) diff --git a/src/tpetra/test/test_tpetra_multivector.f90 b/src/tpetra/test/test_tpetra_multivector.f90 index 28d4589b..c4a8f62c 100644 --- a/src/tpetra/test/test_tpetra_multivector.f90 +++ b/src/tpetra/test/test_tpetra_multivector.f90 @@ -61,7 +61,7 @@ program test_TpetraMultiVector type(TpetraMultiVector) :: A, B, A2, C integer(size_type), parameter :: num_vecs=2, num_local=2, LDA=2 integer(local_ordinal_type) :: lclrow - logical(bool_type) :: zeroout + logical :: zeroout real(scalar_type), parameter :: zero=0., one=1., two=2., four=4., negone=-1. real(scalar_type) :: norms(num_vecs), zeros(num_vecs), values(6) integer(global_ordinal_type) :: gblrow, num_global diff --git a/src/tpetra/tutorials/MapsAndVectors.f90 b/src/tpetra/tutorials/MapsAndVectors.f90 index a7367f4b..ef019a7e 100644 --- a/src/tpetra/tutorials/MapsAndVectors.f90 +++ b/src/tpetra/tutorials/MapsAndVectors.f90 @@ -32,7 +32,7 @@ program main integer(size_type) :: my_rank, num_procs, k integer(size_type) :: num_local_entries, num_elements_per_proc integer(global_size_type) :: num_global_entries -logical(bool_type) :: zero_out +logical :: zero_out real(scalar_type) :: alpha, beta, gamma real(mag_type) :: the_norm real(mag_type), allocatable :: norms(:) diff --git a/src/tpetra/tutorials/PowerMethod.f90 b/src/tpetra/tutorials/PowerMethod.f90 index bb54bb7a..4400235f 100644 --- a/src/tpetra/tutorials/PowerMethod.f90 +++ b/src/tpetra/tutorials/PowerMethod.f90 @@ -216,7 +216,7 @@ subroutine PowerMethod(A, lambda, iconv, comm, verbose_in) implicit None integer(int_type), intent(out) :: iconv real(scalar_type), intent(out) :: lambda - logical(bool_type), intent(in), optional :: verbose_in + logical, intent(in), optional :: verbose_in type(TpetraCrsMatrix), intent(in) :: A type(TeuchosComm), intent(in) :: comm ! ----------------------------------------------------------------------- ! @@ -244,7 +244,7 @@ subroutine PowerMethod(A, lambda, iconv, comm, verbose_in) real(scalar_type) :: normz, residual integer(int_type) :: report_frequency, it integer(size_type) :: my_rank - logical(bool_type) :: verbose + logical :: verbose ! -- Local Arrays real(scalar_type) :: norms(num_vecs), dots(num_vecs) diff --git a/src/utils/src/fortest.f90 b/src/utils/src/fortest.f90 index 740e48d8..df70b029 100644 --- a/src/utils/src/fortest.f90 +++ b/src/utils/src/fortest.f90 @@ -117,10 +117,6 @@ module fortest fortest_inequality_long1 end interface -interface fortest_assert - module procedure fortest_assert1, fortest_assert2 -end interface - public contains @@ -1161,7 +1157,7 @@ end subroutine fortest_inequality_size_t1 ! -------------------------------------------------------------------------- ! - subroutine fortest_assert1(success, filename, lineno, namec, c) + subroutine fortest_assert(success, filename, lineno, namec, c) ! ------------------------------------------------------------------------ ! logical, intent(inout) :: success character(len=*), intent(in) :: filename, namec @@ -1179,29 +1175,7 @@ subroutine fortest_assert1(success, filename, lineno, namec, c) end if call gather_success(lcl_success, success) return - end subroutine fortest_assert1 - - ! -------------------------------------------------------------------------- ! - - subroutine fortest_assert2(success, filename, lineno, namec, c) - ! ------------------------------------------------------------------------ ! - logical, intent(inout) :: success - character(len=*), intent(in) :: filename, namec - integer, intent(in) :: lineno - logical(c_bool), intent(in) :: c - character(len=30) :: name - character(len=256) :: signature - logical :: lcl_success - ! ------------------------------------------------------------------------ ! - name = 'TEST_ASSERT' - lcl_success = c - if (.not. lcl_success) then - signature = trim(name) // '(' // trim(namec) // ')' - call write_error_diagnostics(filename, lineno, signature) - end if - call gather_success(lcl_success, success) - return - end subroutine fortest_assert2 + end subroutine fortest_assert ! -------------------------------------------------------------------------- ! From a62ea8798ba8651c21635d838dad2c67796989bb Mon Sep 17 00:00:00 2001 From: Seth R Johnson Date: Fri, 1 Feb 2019 13:27:27 -0500 Subject: [PATCH 05/40] Use F90 instead of f90 to enable C preprocessing The -cpp option interferes with CMake's Ninja generator. --- CMakeLists.txt | 9 ++++++--- cmake/UseSWIGFortran.cmake | 2 +- src/belos/src/CMakeLists.txt | 2 +- src/belos/src/swig/{forbelos.f90 => forbelos.F90} | 0 src/belos/test/CMakeLists.txt | 2 +- .../{test_belos_types.f90 => test_belos_types.F90} | 0 src/interface/src/CMakeLists.txt | 2 +- .../src/swig/{fortrilinos.f90 => fortrilinos.F90} | 0 src/interface/test/CMakeLists.txt | 8 ++++---- ...uator_1DFEM.f90 => Tpetra_ModelEvaluator_1DFEM.F90} | 0 .../{test_eigen_handle.f90 => test_eigen_handle.F90} | 0 ...ity_reproducer.f90 => test_futility_reproducer.F90} | 0 src/interface/test/{test_nox.f90 => test_nox.F90} | 0 .../{test_solver_handle.f90 => test_solver_handle.F90} | 0 src/teuchos/src/CMakeLists.txt | 2 +- .../src/swig/{forteuchos.f90 => forteuchos.F90} | 0 src/teuchos/test/CMakeLists.txt | 4 ++-- .../{test_teuchos_comm.f90 => test_teuchos_comm.F90} | 2 +- .../{test_teuchos_plist.f90 => test_teuchos_plist.F90} | 2 +- src/tpetra/src/.gitignore | 2 +- src/tpetra/src/CMakeLists.txt | 2 +- src/tpetra/src/swig/{fortpetra.f90 => fortpetra.F90} | 0 src/tpetra/test/CMakeLists.txt | 10 +++++----- ...st_tpetra_crsgraph.f90 => test_tpetra_crsgraph.F90} | 2 +- ..._tpetra_crsmatrix.f90 => test_tpetra_crsmatrix.F90} | 2 +- ...import_export.f90 => test_tpetra_import_export.F90} | 2 +- .../test/{test_tpetra_map.f90 => test_tpetra_map.F90} | 2 +- ...tra_multivector.f90 => test_tpetra_multivector.F90} | 0 src/tpetra/tutorials/CMakeLists.txt | 4 ++-- .../{MapsAndVectors.f90 => MapsAndVectors.F90} | 0 .../tutorials/{PowerMethod.f90 => PowerMethod.F90} | 0 src/utils/src/CMakeLists.txt | 4 ++-- src/utils/src/{fortest.f90 => fortest.F90} | 0 src/utils/src/swig/{forerror.f90 => forerror.F90} | 0 34 files changed, 34 insertions(+), 31 deletions(-) rename src/belos/src/swig/{forbelos.f90 => forbelos.F90} (100%) rename src/belos/test/{test_belos_types.f90 => test_belos_types.F90} (100%) rename src/interface/src/swig/{fortrilinos.f90 => fortrilinos.F90} (100%) rename src/interface/test/{Tpetra_ModelEvaluator_1DFEM.f90 => Tpetra_ModelEvaluator_1DFEM.F90} (100%) rename src/interface/test/{test_eigen_handle.f90 => test_eigen_handle.F90} (100%) rename src/interface/test/{test_futility_reproducer.f90 => test_futility_reproducer.F90} (100%) rename src/interface/test/{test_nox.f90 => test_nox.F90} (100%) rename src/interface/test/{test_solver_handle.f90 => test_solver_handle.F90} (100%) rename src/teuchos/src/swig/{forteuchos.f90 => forteuchos.F90} (100%) rename src/teuchos/test/{test_teuchos_comm.f90 => test_teuchos_comm.F90} (95%) rename src/teuchos/test/{test_teuchos_plist.f90 => test_teuchos_plist.F90} (98%) rename src/tpetra/src/swig/{fortpetra.f90 => fortpetra.F90} (100%) rename src/tpetra/test/{test_tpetra_crsgraph.f90 => test_tpetra_crsgraph.F90} (99%) rename src/tpetra/test/{test_tpetra_crsmatrix.f90 => test_tpetra_crsmatrix.F90} (99%) rename src/tpetra/test/{test_tpetra_import_export.f90 => test_tpetra_import_export.F90} (99%) rename src/tpetra/test/{test_tpetra_map.f90 => test_tpetra_map.F90} (99%) rename src/tpetra/test/{test_tpetra_multivector.f90 => test_tpetra_multivector.F90} (100%) rename src/tpetra/tutorials/{MapsAndVectors.f90 => MapsAndVectors.F90} (100%) rename src/tpetra/tutorials/{PowerMethod.f90 => PowerMethod.F90} (100%) rename src/utils/src/{fortest.f90 => fortest.F90} (100%) rename src/utils/src/swig/{forerror.f90 => forerror.F90} (100%) diff --git a/CMakeLists.txt b/CMakeLists.txt index 432e1b91..f0c4f6fc 100644 --- a/CMakeLists.txt +++ b/CMakeLists.txt @@ -16,8 +16,10 @@ TRIBITS_PACKAGE_DECL(ForTrilinos) TRIBITS_ADD_DEBUG_OPTION() TRIBITS_ADD_SHOW_DEPRECATED_WARNINGS_OPTION() -# Enable unlimited-length lines and C-like preprocessing -SET(CMAKE_Fortran_FLAGS "-ffree-line-length-none -cpp ${CMAKE_Fortran_FLAGS}") +# Enable unlimited-length lines +if (CMAKE_Fortran_COMPILER_ID STREQUAL "GNU") + SET(CMAKE_Fortran_FLAGS "-ffree-line-length-none ${CMAKE_Fortran_FLAGS}") +endif() IF (${PACKAGE_NAME}_ENABLE_DeveloperMode) # SWIG setup @@ -33,7 +35,8 @@ IF (${PACKAGE_NAME}_ENABLE_DeveloperMode) # Ignore some SWIG warnings: # 401: "Nothing known about base class" - LIST(APPEND CMAKE_SWIG_FLAGS "-w401") + LIST(APPEND CMAKE_SWIG_FLAGS "-w401" "-fext" "F90") + set(SWIG_FORTRAN_EXTRA_FILE_EXTENSIONS ".F90") IF (NOT TPL_ENABLE_MPI) # Warn if MPI is disabled since not all wrapper functions will be diff --git a/cmake/UseSWIGFortran.cmake b/cmake/UseSWIGFortran.cmake index 8c0dc98d..8597854d 100644 --- a/cmake/UseSWIGFortran.cmake +++ b/cmake/UseSWIGFortran.cmake @@ -322,7 +322,7 @@ function(SWIG_GET_EXTRA_OUTPUT_FILES language outfiles generatedpath infile) set(extra_file "${generatedpath}/${module_basename}${it}") if (extra_file MATCHES "\\.cs$" AND CMAKE_CSharp_COMPILER_LOADED) set_source_files_properties(${extra_file} PROPERTIES LANGUAGE "CSharp") - elseif (extra_file MATCHES "\\.f90$" AND CMAKE_Fortran_COMPILER_LOADED) + elseif (extra_file MATCHES "\\.[fF]90$" AND CMAKE_Fortran_COMPILER_LOADED) set_source_files_properties(${extra_file} PROPERTIES LANGUAGE "Fortran") else() # Treat extra outputs as plain files regardless of language. diff --git a/src/belos/src/CMakeLists.txt b/src/belos/src/CMakeLists.txt index 7e239779..397d00ac 100644 --- a/src/belos/src/CMakeLists.txt +++ b/src/belos/src/CMakeLists.txt @@ -20,7 +20,7 @@ IF (ForTrilinos_ENABLE_DeveloperMode) ELSE() # Use pre-generated files SET(GEN_SOURCE - swig/forbelos.f90 + swig/forbelos.F90 swig/forbelosFORTRAN_wrap.cxx) TRIBITS_ADD_LIBRARY( diff --git a/src/belos/src/swig/forbelos.f90 b/src/belos/src/swig/forbelos.F90 similarity index 100% rename from src/belos/src/swig/forbelos.f90 rename to src/belos/src/swig/forbelos.F90 diff --git a/src/belos/test/CMakeLists.txt b/src/belos/test/CMakeLists.txt index ae91dc3b..a47110db 100644 --- a/src/belos/test/CMakeLists.txt +++ b/src/belos/test/CMakeLists.txt @@ -8,7 +8,7 @@ ##---------------------------------------------------------------------------## SET(TESTS - test_belos_types.f90 + test_belos_types.F90 ) FOREACH(test ${TESTS}) diff --git a/src/belos/test/test_belos_types.f90 b/src/belos/test/test_belos_types.F90 similarity index 100% rename from src/belos/test/test_belos_types.f90 rename to src/belos/test/test_belos_types.F90 diff --git a/src/interface/src/CMakeLists.txt b/src/interface/src/CMakeLists.txt index 6c8528ff..fded30a1 100644 --- a/src/interface/src/CMakeLists.txt +++ b/src/interface/src/CMakeLists.txt @@ -30,7 +30,7 @@ IF (ForTrilinos_ENABLE_DeveloperMode) ELSE() # Use pre-generated files SET(GEN_SOURCE - swig/fortrilinos.f90 + swig/fortrilinos.F90 swig/fortrilinosFORTRAN_wrap.cxx) TRIBITS_ADD_LIBRARY( diff --git a/src/interface/src/swig/fortrilinos.f90 b/src/interface/src/swig/fortrilinos.F90 similarity index 100% rename from src/interface/src/swig/fortrilinos.f90 rename to src/interface/src/swig/fortrilinos.F90 diff --git a/src/interface/test/CMakeLists.txt b/src/interface/test/CMakeLists.txt index abfb6aff..aab071ae 100644 --- a/src/interface/test/CMakeLists.txt +++ b/src/interface/test/CMakeLists.txt @@ -16,7 +16,7 @@ IF (${PACKAGE_NAME}_ENABLE_Belos AND ${PACKAGE_NAME}_ENABLE_Ifpack2) TRIBITS_ADD_EXECUTABLE_AND_TEST( test_solver_handle_test_fortran - SOURCES test_solver_handle.f90 + SOURCES test_solver_handle.F90 LINKER_LANGUAGE Fortran COMM serial mpi ) @@ -41,7 +41,7 @@ IF (${PACKAGE_NAME}_ENABLE_Anasazi) TRIBITS_ADD_EXECUTABLE_AND_TEST( test_eigen_handle_fortran - SOURCES test_eigen_handle.f90 + SOURCES test_eigen_handle.F90 LINKER_LANGUAGE Fortran COMM serial mpi NUM_MPI_PROCS 1 @@ -49,7 +49,7 @@ IF (${PACKAGE_NAME}_ENABLE_Anasazi) TRIBITS_ADD_EXECUTABLE_AND_TEST( test_futility - SOURCES test_futility_reproducer.f90 + SOURCES test_futility_reproducer.F90 LINKER_LANGUAGE Fortran COMM serial mpi NUM_MPI_PROCS 1 @@ -65,7 +65,7 @@ TRIBITS_ADD_EXECUTABLE_AND_TEST( TRIBITS_ADD_EXECUTABLE_AND_TEST( test_nox_fortran - SOURCES Tpetra_ModelEvaluator_1DFEM.f90 test_nox.f90 + SOURCES Tpetra_ModelEvaluator_1DFEM.F90 test_nox.F90 LINKER_LANGUAGE Fortran STANDARD_PASS_OUTPUT COMM serial mpi diff --git a/src/interface/test/Tpetra_ModelEvaluator_1DFEM.f90 b/src/interface/test/Tpetra_ModelEvaluator_1DFEM.F90 similarity index 100% rename from src/interface/test/Tpetra_ModelEvaluator_1DFEM.f90 rename to src/interface/test/Tpetra_ModelEvaluator_1DFEM.F90 diff --git a/src/interface/test/test_eigen_handle.f90 b/src/interface/test/test_eigen_handle.F90 similarity index 100% rename from src/interface/test/test_eigen_handle.f90 rename to src/interface/test/test_eigen_handle.F90 diff --git a/src/interface/test/test_futility_reproducer.f90 b/src/interface/test/test_futility_reproducer.F90 similarity index 100% rename from src/interface/test/test_futility_reproducer.f90 rename to src/interface/test/test_futility_reproducer.F90 diff --git a/src/interface/test/test_nox.f90 b/src/interface/test/test_nox.F90 similarity index 100% rename from src/interface/test/test_nox.f90 rename to src/interface/test/test_nox.F90 diff --git a/src/interface/test/test_solver_handle.f90 b/src/interface/test/test_solver_handle.F90 similarity index 100% rename from src/interface/test/test_solver_handle.f90 rename to src/interface/test/test_solver_handle.F90 diff --git a/src/teuchos/src/CMakeLists.txt b/src/teuchos/src/CMakeLists.txt index b1305c47..4fbbf1e0 100644 --- a/src/teuchos/src/CMakeLists.txt +++ b/src/teuchos/src/CMakeLists.txt @@ -17,7 +17,7 @@ IF (ForTrilinos_ENABLE_DeveloperMode) ELSE() # Use pre-generated files SET(GEN_SOURCE - swig/forteuchos.f90 + swig/forteuchos.F90 swig/forteuchosFORTRAN_wrap.cxx) TRIBITS_ADD_LIBRARY( diff --git a/src/teuchos/src/swig/forteuchos.f90 b/src/teuchos/src/swig/forteuchos.F90 similarity index 100% rename from src/teuchos/src/swig/forteuchos.f90 rename to src/teuchos/src/swig/forteuchos.F90 diff --git a/src/teuchos/test/CMakeLists.txt b/src/teuchos/test/CMakeLists.txt index 3dc86d7c..3218d425 100644 --- a/src/teuchos/test/CMakeLists.txt +++ b/src/teuchos/test/CMakeLists.txt @@ -8,8 +8,8 @@ ##---------------------------------------------------------------------------## SET(TESTS - test_teuchos_comm.f90 - test_teuchos_plist.f90 + test_teuchos_comm.F90 + test_teuchos_plist.F90 ) FOREACH(test ${TESTS}) diff --git a/src/teuchos/test/test_teuchos_comm.f90 b/src/teuchos/test/test_teuchos_comm.F90 similarity index 95% rename from src/teuchos/test/test_teuchos_comm.f90 rename to src/teuchos/test/test_teuchos_comm.F90 index f11f5f11..94748f47 100644 --- a/src/teuchos/test/test_teuchos_comm.f90 +++ b/src/teuchos/test/test_teuchos_comm.F90 @@ -15,7 +15,7 @@ program test_TeuchosComm use forteuchos implicit none - character(len=26), parameter :: FILENAME='test_teuchos_comm.f90' + character(len=26), parameter :: FILENAME='test_teuchos_comm.F90' integer :: ierr, mpicomm diff --git a/src/teuchos/test/test_teuchos_plist.f90 b/src/teuchos/test/test_teuchos_plist.F90 similarity index 98% rename from src/teuchos/test/test_teuchos_plist.f90 rename to src/teuchos/test/test_teuchos_plist.F90 index 03fe8e18..d366efa0 100644 --- a/src/teuchos/test/test_teuchos_plist.f90 +++ b/src/teuchos/test/test_teuchos_plist.F90 @@ -11,7 +11,7 @@ program test_TeuchosPList use forteuchos implicit none - character(len=26), parameter :: FILENAME='test_teuchos_plist.f90' + character(len=26), parameter :: FILENAME='test_teuchos_plist.F90' SETUP_TEST() diff --git a/src/tpetra/src/.gitignore b/src/tpetra/src/.gitignore index e7af340c..6ed9a4ee 100644 --- a/src/tpetra/src/.gitignore +++ b/src/tpetra/src/.gitignore @@ -1 +1 @@ -*_autogen.f90 +*_autogen.F90 diff --git a/src/tpetra/src/CMakeLists.txt b/src/tpetra/src/CMakeLists.txt index a56680ee..48f52e6b 100644 --- a/src/tpetra/src/CMakeLists.txt +++ b/src/tpetra/src/CMakeLists.txt @@ -20,7 +20,7 @@ IF (ForTrilinos_ENABLE_DeveloperMode) ELSE() # Use pre-generated files SET(GEN_SOURCE - swig/fortpetra.f90 + swig/fortpetra.F90 swig/fortpetraFORTRAN_wrap.cxx) TRIBITS_ADD_LIBRARY( diff --git a/src/tpetra/src/swig/fortpetra.f90 b/src/tpetra/src/swig/fortpetra.F90 similarity index 100% rename from src/tpetra/src/swig/fortpetra.f90 rename to src/tpetra/src/swig/fortpetra.F90 diff --git a/src/tpetra/test/CMakeLists.txt b/src/tpetra/test/CMakeLists.txt index 16b34cd3..890f3745 100644 --- a/src/tpetra/test/CMakeLists.txt +++ b/src/tpetra/test/CMakeLists.txt @@ -8,11 +8,11 @@ ##---------------------------------------------------------------------------## SET(TESTS - test_tpetra_map.f90 - test_tpetra_crsgraph.f90 - test_tpetra_crsmatrix.f90 - test_tpetra_multivector.f90 - test_tpetra_import_export.f90 + test_tpetra_map.F90 + test_tpetra_crsgraph.F90 + test_tpetra_crsmatrix.F90 + test_tpetra_multivector.F90 + test_tpetra_import_export.F90 ) FOREACH(test ${TESTS}) diff --git a/src/tpetra/test/test_tpetra_crsgraph.f90 b/src/tpetra/test/test_tpetra_crsgraph.F90 similarity index 99% rename from src/tpetra/test/test_tpetra_crsgraph.f90 rename to src/tpetra/test/test_tpetra_crsgraph.F90 index e623fb76..ea7f231e 100644 --- a/src/tpetra/test/test_tpetra_crsgraph.f90 +++ b/src/tpetra/test/test_tpetra_crsgraph.F90 @@ -12,7 +12,7 @@ program test_TpetraCrsGraph implicit none type(TeuchosComm) :: comm - character(len=26), parameter :: FILENAME="test_tpetra_crsgraph.f90" + character(len=26), parameter :: FILENAME="test_tpetra_crsgraph.F90" SETUP_TEST() diff --git a/src/tpetra/test/test_tpetra_crsmatrix.f90 b/src/tpetra/test/test_tpetra_crsmatrix.F90 similarity index 99% rename from src/tpetra/test/test_tpetra_crsmatrix.f90 rename to src/tpetra/test/test_tpetra_crsmatrix.F90 index d6a925ea..74591348 100644 --- a/src/tpetra/test/test_tpetra_crsmatrix.f90 +++ b/src/tpetra/test/test_tpetra_crsmatrix.F90 @@ -12,7 +12,7 @@ program test_TpetraCrsMatrix implicit none type(TeuchosComm) :: comm - character(len=256), parameter :: FILENAME="test_tpetra_crsmatrix.f90" + character(len=256), parameter :: FILENAME="test_tpetra_crsmatrix.F90" SETUP_TEST() diff --git a/src/tpetra/test/test_tpetra_import_export.f90 b/src/tpetra/test/test_tpetra_import_export.F90 similarity index 99% rename from src/tpetra/test/test_tpetra_import_export.f90 rename to src/tpetra/test/test_tpetra_import_export.F90 index db570f63..d7703db1 100644 --- a/src/tpetra/test/test_tpetra_import_export.f90 +++ b/src/tpetra/test/test_tpetra_import_export.F90 @@ -12,7 +12,7 @@ program test_TpetraImportExport implicit none type(TeuchosComm) :: comm - character(len=30), parameter :: FILENAME="test_tpetraimport_export.f90" + character(len=30), parameter :: FILENAME="test_tpetraimport_export.F90" SETUP_TEST() diff --git a/src/tpetra/test/test_tpetra_map.f90 b/src/tpetra/test/test_tpetra_map.F90 similarity index 99% rename from src/tpetra/test/test_tpetra_map.f90 rename to src/tpetra/test/test_tpetra_map.F90 index c7677a6e..acc29c18 100644 --- a/src/tpetra/test/test_tpetra_map.f90 +++ b/src/tpetra/test/test_tpetra_map.F90 @@ -12,7 +12,7 @@ program test_TpetraMap implicit none type(TeuchosComm) :: comm - character(len=256), parameter :: FILENAME="test_tpetra_map.f90" + character(len=256), parameter :: FILENAME="test_tpetra_map.F90" SETUP_TEST() diff --git a/src/tpetra/test/test_tpetra_multivector.f90 b/src/tpetra/test/test_tpetra_multivector.F90 similarity index 100% rename from src/tpetra/test/test_tpetra_multivector.f90 rename to src/tpetra/test/test_tpetra_multivector.F90 diff --git a/src/tpetra/tutorials/CMakeLists.txt b/src/tpetra/tutorials/CMakeLists.txt index 30f9a0e3..b87d7988 100644 --- a/src/tpetra/tutorials/CMakeLists.txt +++ b/src/tpetra/tutorials/CMakeLists.txt @@ -8,8 +8,8 @@ ##---------------------------------------------------------------------------## SET(TESTS - PowerMethod.f90 - MapsAndVectors.f90 + PowerMethod.F90 + MapsAndVectors.F90 ) FOREACH(test ${TESTS}) diff --git a/src/tpetra/tutorials/MapsAndVectors.f90 b/src/tpetra/tutorials/MapsAndVectors.F90 similarity index 100% rename from src/tpetra/tutorials/MapsAndVectors.f90 rename to src/tpetra/tutorials/MapsAndVectors.F90 diff --git a/src/tpetra/tutorials/PowerMethod.f90 b/src/tpetra/tutorials/PowerMethod.F90 similarity index 100% rename from src/tpetra/tutorials/PowerMethod.f90 rename to src/tpetra/tutorials/PowerMethod.F90 diff --git a/src/utils/src/CMakeLists.txt b/src/utils/src/CMakeLists.txt index e494dac5..43c67939 100644 --- a/src/utils/src/CMakeLists.txt +++ b/src/utils/src/CMakeLists.txt @@ -18,7 +18,7 @@ IF (ForTrilinos_ENABLE_DeveloperMode) ELSE() # Use pre-generated files SET(GEN_SOURCE - swig/forerror.f90 + swig/forerror.F90 swig/forerrorFORTRAN_wrap.cxx) TRIBITS_ADD_LIBRARY( @@ -29,7 +29,7 @@ ENDIF() TRIBITS_ADD_LIBRARY( forutils NOINSTALLHEADERS FortranTestUtilities.h - SOURCES fortest.f90 + SOURCES fortest.F90 DEPLIBS forerror ) diff --git a/src/utils/src/fortest.f90 b/src/utils/src/fortest.F90 similarity index 100% rename from src/utils/src/fortest.f90 rename to src/utils/src/fortest.F90 diff --git a/src/utils/src/swig/forerror.f90 b/src/utils/src/swig/forerror.F90 similarity index 100% rename from src/utils/src/swig/forerror.f90 rename to src/utils/src/swig/forerror.F90 From 309980f860233cef37eee0304dfe4cd5a71891dc Mon Sep 17 00:00:00 2001 From: Seth R Johnson Date: Fri, 1 Feb 2019 14:44:57 -0500 Subject: [PATCH 06/40] Add native ArrayView type mapping --- src/teuchos/src/Teuchos_Array.i | 32 +- src/teuchos/src/Teuchos_ArrayView.i | 54 ++ src/teuchos/src/forteuchos.i | 1 + src/teuchos/src/swig/forteuchos.F90 | 299 ++++++++++- .../src/swig/forteuchosFORTRAN_wrap.cxx | 505 +++++++++++++++--- src/teuchos/test/CMakeLists.txt | 1 + src/teuchos/test/test_teuchos_array.F90 | 43 ++ 7 files changed, 848 insertions(+), 87 deletions(-) create mode 100644 src/teuchos/src/Teuchos_ArrayView.i create mode 100644 src/teuchos/test/test_teuchos_array.F90 diff --git a/src/teuchos/src/Teuchos_Array.i b/src/teuchos/src/Teuchos_Array.i index e56ea751..9b1afbb6 100644 --- a/src/teuchos/src/Teuchos_Array.i +++ b/src/teuchos/src/Teuchos_Array.i @@ -13,24 +13,28 @@ namespace Teuchos { -template +template class Array { - public: - typedef T value_type; + public: + typedef _Tp value_type; typedef std::size_t size_type; -}; -} -%define TEUCHOS_ARRAY(TYPE...) + // Implicit conversion from array view + Array(const ArrayView&); -// Add native wrapping typemaps to convert to/from Teuchos array -%std_native_container(Teuchos::Array) -// Instantiate the typemaps without generating wrappers -%template() Teuchos::Array; + // Wrap like a std::vector: const references and values are treated as + // native Fortran data; mutable references and pointers are wrapped. + %std_native_container(Teuchos::Array<_Tp>) -%enddef + %extend { + ArrayView<_Tp> view() { + return (*$self)(); + } + } +}; +} -TEUCHOS_ARRAY(int); -TEUCHOS_ARRAY(double); -TEUCHOS_ARRAY(long long); +%template(TeuchosArrayInt) Teuchos::Array; +%template(TeuchosArrayDbl) Teuchos::Array; +%template(TeuchosArrayLongLong) Teuchos::Array; diff --git a/src/teuchos/src/Teuchos_ArrayView.i b/src/teuchos/src/Teuchos_ArrayView.i new file mode 100644 index 00000000..01bce98e --- /dev/null +++ b/src/teuchos/src/Teuchos_ArrayView.i @@ -0,0 +1,54 @@ +/* + * Copyright 2017-2018, UT-Battelle, LLC + * + * SPDX-License-Identifier: BSD-3-Clause + * License-Filename: LICENSE + */ +%{ +#include "Teuchos_ArrayView.hpp" +%} + +%include + +namespace Teuchos +{ +template +class ArrayView +{ + public: + typedef _Tp value_type; + typedef std::size_t size_type; + + // Add native wrapping typemaps to convert to/from Teuchos array + %fortran_array_pointer(_Tp, ArrayView<_Tp>) + + %typemap(in, noblock=1) ArrayView<_Tp> (_Tp* tempbegin, Teuchos::ArrayView<_Tp> temparr) { + tempbegin = static_cast<_Tp*>($input->data); + temparr = Teuchos::ArrayView<_Tp>(tempbegin, $input->size); + $1 = &temparr; + } + + %typemap(out, noblock=1) ArrayView<_Tp> { + $result.data = $1.getRawPtr(); + $result.size = $1.size(); + } + + // XXX: %apply only works for *NAME-INSTANTIATED* types, not %template() + // types, so we have to manually copy these typemaps. + %typemap(in) const ArrayView<_Tp> & = ArrayView<_Tp>; + %typemap(ctype) const ArrayView<_Tp> & = ArrayView<_Tp>; + %typemap(imtype) const ArrayView<_Tp> & = ArrayView<_Tp>; + %typemap(ftype) const ArrayView<_Tp> & = ArrayView<_Tp>; + %typemap(fin) const ArrayView<_Tp> & = ArrayView<_Tp>; + %typemap(findecl) const ArrayView<_Tp> & = ArrayView<_Tp>; +}; +} + +// Instantiate typemaps only +%template() Teuchos::ArrayView; +%template() Teuchos::ArrayView; +%template() Teuchos::ArrayView; + +%template() Teuchos::ArrayView; +%template() Teuchos::ArrayView; +%template() Teuchos::ArrayView; diff --git a/src/teuchos/src/forteuchos.i b/src/teuchos/src/forteuchos.i index 117f2195..f84f7699 100644 --- a/src/teuchos/src/forteuchos.i +++ b/src/teuchos/src/forteuchos.i @@ -40,6 +40,7 @@ namespace Teuchos { %include "Teuchos_Exceptions.i" %include "Teuchos_RCP.i" +%include "Teuchos_ArrayView.i" %include "Teuchos_Array.i" %include "Teuchos_Comm.i" %include "Teuchos_ParameterList.i" diff --git a/src/teuchos/src/swig/forteuchos.F90 b/src/teuchos/src/swig/forteuchos.F90 index 6f6a94f0..7b2a48a2 100644 --- a/src/teuchos/src/swig/forteuchos.F90 +++ b/src/teuchos/src/swig/forteuchos.F90 @@ -77,6 +77,46 @@ module forteuchos type(C_PTR), public :: cptr = C_NULL_PTR integer(C_INT), public :: mem = SWIG_NULL end type + type, bind(C) :: SwigArrayWrapper + type(C_PTR), public :: data = C_NULL_PTR + integer(C_SIZE_T), public :: size = 0 + end type + ! class Teuchos::Array< int > + type, public :: TeuchosArrayInt + type(SwigClassWrapper), public :: swigdata + contains + procedure :: view => swigf_TeuchosArrayInt_view + procedure :: release => delete_TeuchosArrayInt + procedure, private :: swigf_assignment_TeuchosArrayInt + generic :: assignment(=) => swigf_assignment_TeuchosArrayInt + end type TeuchosArrayInt + interface TeuchosArrayInt + module procedure new_TeuchosArrayInt + end interface + ! class Teuchos::Array< double > + type, public :: TeuchosArrayDbl + type(SwigClassWrapper), public :: swigdata + contains + procedure :: view => swigf_TeuchosArrayDbl_view + procedure :: release => delete_TeuchosArrayDbl + procedure, private :: swigf_assignment_TeuchosArrayDbl + generic :: assignment(=) => swigf_assignment_TeuchosArrayDbl + end type TeuchosArrayDbl + interface TeuchosArrayDbl + module procedure new_TeuchosArrayDbl + end interface + ! class Teuchos::Array< long long > + type, public :: TeuchosArrayLongLong + type(SwigClassWrapper), public :: swigdata + contains + procedure :: view => swigf_TeuchosArrayLongLong_view + procedure :: release => delete_TeuchosArrayLongLong + procedure, private :: swigf_assignment_TeuchosArrayLongLong + generic :: assignment(=) => swigf_assignment_TeuchosArrayLongLong + end type TeuchosArrayLongLong + interface TeuchosArrayLongLong + module procedure new_TeuchosArrayLongLong + end interface ! class Teuchos::Comm< int > type, public :: TeuchosComm type(SwigClassWrapper), public :: swigdata @@ -93,10 +133,6 @@ module forteuchos module procedure new_TeuchosComm__SWIG_0 module procedure new_TeuchosComm__SWIG_1 end interface - type, bind(C) :: SwigArrayWrapper - type(C_PTR), public :: data = C_NULL_PTR - integer(C_SIZE_T), public :: size = 0 - end type ! class Teuchos::ParameterList type, public :: ParameterList type(SwigClassWrapper), public :: swigdata @@ -137,6 +173,108 @@ module forteuchos ! WRAPPER DECLARATIONS interface +function swigc_new_TeuchosArrayInt(farg1) & +bind(C, name="_wrap_new_TeuchosArrayInt") & +result(fresult) +use, intrinsic :: ISO_C_BINDING +import :: swigclasswrapper +import :: swigarraywrapper +type(SwigArrayWrapper) :: farg1 +type(SwigClassWrapper) :: fresult +end function + +function swigc_TeuchosArrayInt_view(farg1) & +bind(C, name="_wrap_TeuchosArrayInt_view") & +result(fresult) +use, intrinsic :: ISO_C_BINDING +import :: swigarraywrapper +import :: swigclasswrapper +type(SwigClassWrapper) :: farg1 +type(SwigArrayWrapper) :: fresult +end function + +subroutine swigc_delete_TeuchosArrayInt(farg1) & +bind(C, name="_wrap_delete_TeuchosArrayInt") +use, intrinsic :: ISO_C_BINDING +import :: swigclasswrapper +type(SwigClassWrapper) :: farg1 +end subroutine + + subroutine swigc_assignment_TeuchosArrayInt(self, other) & + bind(C, name="_wrap_assign_TeuchosArrayInt") + use, intrinsic :: ISO_C_BINDING + import :: SwigClassWrapper + type(SwigClassWrapper), intent(inout) :: self + type(SwigClassWrapper), intent(in) :: other + end subroutine +function swigc_new_TeuchosArrayDbl(farg1) & +bind(C, name="_wrap_new_TeuchosArrayDbl") & +result(fresult) +use, intrinsic :: ISO_C_BINDING +import :: swigclasswrapper +import :: swigarraywrapper +type(SwigArrayWrapper) :: farg1 +type(SwigClassWrapper) :: fresult +end function + +function swigc_TeuchosArrayDbl_view(farg1) & +bind(C, name="_wrap_TeuchosArrayDbl_view") & +result(fresult) +use, intrinsic :: ISO_C_BINDING +import :: swigarraywrapper +import :: swigclasswrapper +type(SwigClassWrapper) :: farg1 +type(SwigArrayWrapper) :: fresult +end function + +subroutine swigc_delete_TeuchosArrayDbl(farg1) & +bind(C, name="_wrap_delete_TeuchosArrayDbl") +use, intrinsic :: ISO_C_BINDING +import :: swigclasswrapper +type(SwigClassWrapper) :: farg1 +end subroutine + + subroutine swigc_assignment_TeuchosArrayDbl(self, other) & + bind(C, name="_wrap_assign_TeuchosArrayDbl") + use, intrinsic :: ISO_C_BINDING + import :: SwigClassWrapper + type(SwigClassWrapper), intent(inout) :: self + type(SwigClassWrapper), intent(in) :: other + end subroutine +function swigc_new_TeuchosArrayLongLong(farg1) & +bind(C, name="_wrap_new_TeuchosArrayLongLong") & +result(fresult) +use, intrinsic :: ISO_C_BINDING +import :: swigclasswrapper +import :: swigarraywrapper +type(SwigArrayWrapper) :: farg1 +type(SwigClassWrapper) :: fresult +end function + +function swigc_TeuchosArrayLongLong_view(farg1) & +bind(C, name="_wrap_TeuchosArrayLongLong_view") & +result(fresult) +use, intrinsic :: ISO_C_BINDING +import :: swigarraywrapper +import :: swigclasswrapper +type(SwigClassWrapper) :: farg1 +type(SwigArrayWrapper) :: fresult +end function + +subroutine swigc_delete_TeuchosArrayLongLong(farg1) & +bind(C, name="_wrap_delete_TeuchosArrayLongLong") +use, intrinsic :: ISO_C_BINDING +import :: swigclasswrapper +type(SwigClassWrapper) :: farg1 +end subroutine + + subroutine swigc_assignment_TeuchosArrayLongLong(self, other) & + bind(C, name="_wrap_assign_TeuchosArrayLongLong") + use, intrinsic :: ISO_C_BINDING + import :: SwigClassWrapper + type(SwigClassWrapper), intent(inout) :: self + type(SwigClassWrapper), intent(in) :: other + end subroutine function swigc_TeuchosComm_getRank(farg1) & bind(C, name="_wrap_TeuchosComm_getRank") & result(fresult) @@ -473,6 +611,159 @@ subroutine swigc_save_to_xml(farg1, farg2) & contains ! MODULE SUBPROGRAMS +function new_TeuchosArrayInt(arg0) & +result(self) +use, intrinsic :: ISO_C_BINDING +type(TeuchosArrayInt) :: self +integer(C_INT), dimension(:), target :: arg0 +integer(C_INT), pointer :: farg1_view + +type(SwigClassWrapper) :: fresult +type(SwigArrayWrapper) :: farg1 + +farg1_view => arg0(1) +farg1%data = c_loc(farg1_view) +farg1%size = size(arg0) +fresult = swigc_new_TeuchosArrayInt(farg1) +self%swigdata = fresult +end function + +function swigf_TeuchosArrayInt_view(self) & +result(swig_result) +use, intrinsic :: ISO_C_BINDING +integer(C_INT), dimension(:), pointer :: swig_result +class(TeuchosArrayInt), intent(inout) :: self + +type(SwigArrayWrapper) :: fresult +type(SwigClassWrapper) :: farg1 + +farg1 = self%swigdata +fresult = swigc_TeuchosArrayInt_view(farg1) +call c_f_pointer(fresult%data, swig_result, [fresult%size]) +end function + +subroutine delete_TeuchosArrayInt(self) +use, intrinsic :: ISO_C_BINDING +class(TeuchosArrayInt), intent(inout) :: self + +type(SwigClassWrapper) :: farg1 + +farg1 = self%swigdata +if (self%swigdata%mem == SWIG_OWN) then +call swigc_delete_TeuchosArrayInt(farg1) +end if +self%swigdata%cptr = C_NULL_PTR +self%swigdata%mem = SWIG_NULL +end subroutine + + subroutine swigf_assignment_TeuchosArrayInt(self, other) + use, intrinsic :: ISO_C_BINDING + class(TeuchosArrayInt), intent(inout) :: self + type(TeuchosArrayInt), intent(in) :: other + call swigc_assignment_TeuchosArrayInt(self%swigdata, other%swigdata) + end subroutine +function new_TeuchosArrayDbl(arg0) & +result(self) +use, intrinsic :: ISO_C_BINDING +type(TeuchosArrayDbl) :: self +real(C_DOUBLE), dimension(:), target :: arg0 +real(C_DOUBLE), pointer :: farg1_view + +type(SwigClassWrapper) :: fresult +type(SwigArrayWrapper) :: farg1 + +farg1_view => arg0(1) +farg1%data = c_loc(farg1_view) +farg1%size = size(arg0) +fresult = swigc_new_TeuchosArrayDbl(farg1) +self%swigdata = fresult +end function + +function swigf_TeuchosArrayDbl_view(self) & +result(swig_result) +use, intrinsic :: ISO_C_BINDING +real(C_DOUBLE), dimension(:), pointer :: swig_result +class(TeuchosArrayDbl), intent(inout) :: self + +type(SwigArrayWrapper) :: fresult +type(SwigClassWrapper) :: farg1 + +farg1 = self%swigdata +fresult = swigc_TeuchosArrayDbl_view(farg1) +call c_f_pointer(fresult%data, swig_result, [fresult%size]) +end function + +subroutine delete_TeuchosArrayDbl(self) +use, intrinsic :: ISO_C_BINDING +class(TeuchosArrayDbl), intent(inout) :: self + +type(SwigClassWrapper) :: farg1 + +farg1 = self%swigdata +if (self%swigdata%mem == SWIG_OWN) then +call swigc_delete_TeuchosArrayDbl(farg1) +end if +self%swigdata%cptr = C_NULL_PTR +self%swigdata%mem = SWIG_NULL +end subroutine + + subroutine swigf_assignment_TeuchosArrayDbl(self, other) + use, intrinsic :: ISO_C_BINDING + class(TeuchosArrayDbl), intent(inout) :: self + type(TeuchosArrayDbl), intent(in) :: other + call swigc_assignment_TeuchosArrayDbl(self%swigdata, other%swigdata) + end subroutine +function new_TeuchosArrayLongLong(arg0) & +result(self) +use, intrinsic :: ISO_C_BINDING +type(TeuchosArrayLongLong) :: self +integer(C_LONG_LONG), dimension(:), target :: arg0 +integer(C_LONG_LONG), pointer :: farg1_view + +type(SwigClassWrapper) :: fresult +type(SwigArrayWrapper) :: farg1 + +farg1_view => arg0(1) +farg1%data = c_loc(farg1_view) +farg1%size = size(arg0) +fresult = swigc_new_TeuchosArrayLongLong(farg1) +self%swigdata = fresult +end function + +function swigf_TeuchosArrayLongLong_view(self) & +result(swig_result) +use, intrinsic :: ISO_C_BINDING +integer(C_LONG_LONG), dimension(:), pointer :: swig_result +class(TeuchosArrayLongLong), intent(inout) :: self + +type(SwigArrayWrapper) :: fresult +type(SwigClassWrapper) :: farg1 + +farg1 = self%swigdata +fresult = swigc_TeuchosArrayLongLong_view(farg1) +call c_f_pointer(fresult%data, swig_result, [fresult%size]) +end function + +subroutine delete_TeuchosArrayLongLong(self) +use, intrinsic :: ISO_C_BINDING +class(TeuchosArrayLongLong), intent(inout) :: self + +type(SwigClassWrapper) :: farg1 + +farg1 = self%swigdata +if (self%swigdata%mem == SWIG_OWN) then +call swigc_delete_TeuchosArrayLongLong(farg1) +end if +self%swigdata%cptr = C_NULL_PTR +self%swigdata%mem = SWIG_NULL +end subroutine + + subroutine swigf_assignment_TeuchosArrayLongLong(self, other) + use, intrinsic :: ISO_C_BINDING + class(TeuchosArrayLongLong), intent(inout) :: self + type(TeuchosArrayLongLong), intent(in) :: other + call swigc_assignment_TeuchosArrayLongLong(self%swigdata, other%swigdata) + end subroutine function swigf_TeuchosComm_getRank(self) & result(swig_result) use, intrinsic :: ISO_C_BINDING diff --git a/src/teuchos/src/swig/forteuchosFORTRAN_wrap.cxx b/src/teuchos/src/swig/forteuchosFORTRAN_wrap.cxx index 922b71d0..40208382 100644 --- a/src/teuchos/src/swig/forteuchosFORTRAN_wrap.cxx +++ b/src/teuchos/src/swig/forteuchosFORTRAN_wrap.cxx @@ -205,6 +205,28 @@ void SWIG_store_exception(const char* decl, int errcode, const char *msg); SWIG_store_exception(DECL, CODE, MSG); RETURNNULL; +#define SWIG_check_mutable(SWIG_CLASS_WRAPPER, TYPENAME, FNAME, FUNCNAME, RETURNNULL) \ + if ((SWIG_CLASS_WRAPPER).mem == SWIG_CREF) { \ + SWIG_exception_impl(FUNCNAME, SWIG_TypeError, \ + "Cannot pass const " TYPENAME " (class " FNAME ") " \ + "as a mutable reference", \ + RETURNNULL); \ + } + + +#define SWIG_check_nonnull(SWIG_CLASS_WRAPPER, TYPENAME, FNAME, FUNCNAME, RETURNNULL) \ + if ((SWIG_CLASS_WRAPPER).mem == SWIG_NULL) { \ + SWIG_exception_impl(FUNCNAME, SWIG_TypeError, \ + "Cannot pass null " TYPENAME " (class " FNAME ") " \ + "as a reference", RETURNNULL); \ + } + + +#define SWIG_check_mutable_nonnull(SWIG_CLASS_WRAPPER, TYPENAME, FNAME, FUNCNAME, RETURNNULL) \ + SWIG_check_nonnull(SWIG_CLASS_WRAPPER, TYPENAME, FNAME, FUNCNAME, RETURNNULL); \ + SWIG_check_mutable(SWIG_CLASS_WRAPPER, TYPENAME, FNAME, FUNCNAME, RETURNNULL); + + namespace swig { enum AssignmentFlags { @@ -252,21 +274,6 @@ struct assignment_flags; #define SWIG_as_voidptrptr(a) ((void)SWIG_as_voidptr(*a),reinterpret_cast< void** >(a)) -#include - - -namespace swig { -template -struct assignment_flags, Flags> { - enum { value = IS_DESTR | IS_COPY_CONSTR }; -}; -template -struct assignment_flags, Flags> { - enum { value = IS_DESTR | IS_COPY_CONSTR }; -}; -} - - #include @@ -280,16 +287,10 @@ struct assignment_flags, Flags> { #include "Teuchos_RCP.hpp" -#include "Teuchos_Array.hpp" +#include "Teuchos_ArrayView.hpp" -#include "Teuchos_Comm.hpp" -#ifdef HAVE_MPI -# include "Teuchos_DefaultMpiComm.hpp" -#else - typedef int MPI_Comm; -#endif -#include "Teuchos_DefaultSerialComm.hpp" +#include "Teuchos_Array.hpp" enum SwigMemState { @@ -314,34 +315,37 @@ SWIGINTERN SwigClassWrapper SwigClassWrapper_uninitialized() { return result; } -SWIGINTERN Teuchos::Comm< int > *new_Teuchos_Comm_Sl_int_Sg___SWIG_0(MPI_Comm rawMpiComm){ -#ifdef HAVE_MPI - return new Teuchos::MpiComm(rawMpiComm); -#else - throw std::runtime_error("MPI based constructor cannot be called when MPI is not enabled."); + +#include +#ifdef _MSC_VER +# ifndef strtoull +# define strtoull _strtoui64 +# endif +# ifndef strtoll +# define strtoll _strtoi64 +# endif #endif - } -#define SWIG_NO_NULL_DELETER_0 , Teuchos::RCP_WEAK_NO_DEALLOC -#define SWIG_NO_NULL_DELETER_1 -#define SWIG_NO_NULL_DELETER_SWIG_POINTER_NEW -#define SWIG_NO_NULL_DELETER_SWIG_POINTER_OWN -SWIGINTERN Teuchos::Comm< int > *new_Teuchos_Comm_Sl_int_Sg___SWIG_1(){ -#ifdef HAVE_MPI - return new Teuchos::MpiComm(MPI_COMM_WORLD); -#else - return new Teuchos::SerialComm(); -#endif - } -SWIGINTERN MPI_Comm Teuchos_Comm_Sl_int_Sg__getRawMpiComm(Teuchos::Comm< int > *self){ -#ifdef HAVE_MPI - Teuchos::MpiComm& comm = dynamic_cast&>(*self); - return *comm.getRawMpiComm(); -#else - throw std::runtime_error("MPI based constructor cannot be called when MPI is not enabled."); -#endif - } +struct SwigArrayWrapper { + void* data; + size_t size; +}; + + +SWIGINTERN SwigArrayWrapper SwigArrayWrapper_uninitialized() { + SwigArrayWrapper result; + result.data = NULL; + result.size = 0; + return result; +} + +SWIGINTERN Teuchos::ArrayView< int > Teuchos_Array_Sl_int_Sg__view(Teuchos::Array< int > *self){ + return (*self)(); + } + +#include + namespace swig { @@ -572,33 +576,51 @@ SWIGINTERN void SWIG_assign_impl(SwigClassWrapper* self, SwigClassWrapper* other } } +SWIGINTERN Teuchos::ArrayView< double > Teuchos_Array_Sl_double_Sg__view(Teuchos::Array< double > *self){ + return (*self)(); + } +SWIGINTERN Teuchos::ArrayView< long long > Teuchos_Array_Sl_long_SS_long_Sg__view(Teuchos::Array< long long > *self){ + return (*self)(); + } -#include "Teuchos_ParameterList.hpp" - - -#include -#ifdef _MSC_VER -# ifndef strtoull -# define strtoull _strtoui64 -# endif -# ifndef strtoll -# define strtoll _strtoi64 -# endif +#include "Teuchos_Comm.hpp" +#ifdef HAVE_MPI +# include "Teuchos_DefaultMpiComm.hpp" +#else + typedef int MPI_Comm; #endif +#include "Teuchos_DefaultSerialComm.hpp" +SWIGINTERN Teuchos::Comm< int > *new_Teuchos_Comm_Sl_int_Sg___SWIG_0(MPI_Comm rawMpiComm){ +#ifdef HAVE_MPI + return new Teuchos::MpiComm(rawMpiComm); +#else + throw std::runtime_error("MPI based constructor cannot be called when MPI is not enabled."); +#endif + } -struct SwigArrayWrapper { - void* data; - size_t size; -}; +#define SWIG_NO_NULL_DELETER_0 , Teuchos::RCP_WEAK_NO_DEALLOC +#define SWIG_NO_NULL_DELETER_1 +#define SWIG_NO_NULL_DELETER_SWIG_POINTER_NEW +#define SWIG_NO_NULL_DELETER_SWIG_POINTER_OWN +SWIGINTERN Teuchos::Comm< int > *new_Teuchos_Comm_Sl_int_Sg___SWIG_1(){ +#ifdef HAVE_MPI + return new Teuchos::MpiComm(MPI_COMM_WORLD); +#else + return new Teuchos::SerialComm(); +#endif + } +SWIGINTERN MPI_Comm Teuchos_Comm_Sl_int_Sg__getRawMpiComm(Teuchos::Comm< int > *self){ +#ifdef HAVE_MPI + Teuchos::MpiComm& comm = dynamic_cast&>(*self); + return *comm.getRawMpiComm(); +#else + throw std::runtime_error("MPI based constructor cannot be called when MPI is not enabled."); +#endif + } -SWIGINTERN SwigArrayWrapper SwigArrayWrapper_uninitialized() { - SwigArrayWrapper result; - result.data = NULL; - result.size = 0; - return result; -} +#include "Teuchos_ParameterList.hpp" #include "Teuchos_XMLParameterListCoreHelpers.hpp" @@ -619,6 +641,351 @@ void save_to_xml(const Teuchos::ParameterList& plist, #ifdef __cplusplus extern "C" { #endif +SWIGEXPORT SwigClassWrapper _wrap_new_TeuchosArrayInt(SwigArrayWrapper *farg1) { + SwigClassWrapper fresult ; + Teuchos::ArrayView< int const > *arg1 = 0 ; + int const *tempbegin1 ; + Teuchos::ArrayView< int const > temparr1 ; + Teuchos::Array< int > *result = 0 ; + + tempbegin1 = static_cast(farg1->data); + temparr1 = Teuchos::ArrayView(tempbegin1, farg1->size); + arg1 = &temparr1; + { + // Make sure no unhandled exceptions exist before performing a new action + SWIG_check_unhandled_exception_impl("Teuchos::Array< int >::Array(Teuchos::ArrayView< int const > const &)");; + try + { + // Attempt the wrapped function call + result = (Teuchos::Array< int > *)new Teuchos::Array< int >((Teuchos::ArrayView< int const > const &)*arg1); + } + catch (const std::range_error& e) + { + // Store a C++ exception + SWIG_exception_impl("Teuchos::Array< int >::Array(Teuchos::ArrayView< int const > const &)", SWIG_IndexError, e.what(), return SwigClassWrapper_uninitialized()); + } + catch (const std::exception& e) + { + // Store a C++ exception + SWIG_exception_impl("Teuchos::Array< int >::Array(Teuchos::ArrayView< int const > const &)", SWIG_RuntimeError, e.what(), return SwigClassWrapper_uninitialized()); + } + catch (...) + { + SWIG_exception_impl("Teuchos::Array< int >::Array(Teuchos::ArrayView< int const > const &)", SWIG_UnknownError, "An unknown exception occurred", return SwigClassWrapper_uninitialized()); + } + } + fresult.cptr = result; + fresult.mem = (1 ? SWIG_MOVE : SWIG_REF); + return fresult; +} + + +SWIGEXPORT SwigArrayWrapper _wrap_TeuchosArrayInt_view(SwigClassWrapper const *farg1) { + SwigArrayWrapper fresult ; + Teuchos::Array< int > *arg1 = (Teuchos::Array< int > *) 0 ; + Teuchos::ArrayView< int > result; + + SWIG_check_mutable_nonnull(*farg1, "Teuchos::Array< int > *", "TeuchosArrayInt", "Teuchos::Array< int >::view()", return SwigArrayWrapper_uninitialized()); + arg1 = static_cast< Teuchos::Array< int > * >(farg1->cptr); + { + // Make sure no unhandled exceptions exist before performing a new action + SWIG_check_unhandled_exception_impl("Teuchos::Array< int >::view()");; + try + { + // Attempt the wrapped function call + result = Teuchos_Array_Sl_int_Sg__view(arg1); + } + catch (const std::range_error& e) + { + // Store a C++ exception + SWIG_exception_impl("Teuchos::Array< int >::view()", SWIG_IndexError, e.what(), return SwigArrayWrapper_uninitialized()); + } + catch (const std::exception& e) + { + // Store a C++ exception + SWIG_exception_impl("Teuchos::Array< int >::view()", SWIG_RuntimeError, e.what(), return SwigArrayWrapper_uninitialized()); + } + catch (...) + { + SWIG_exception_impl("Teuchos::Array< int >::view()", SWIG_UnknownError, "An unknown exception occurred", return SwigArrayWrapper_uninitialized()); + } + } + fresult.data = (&result)->getRawPtr(); + fresult.size = (&result)->size(); + return fresult; +} + + +SWIGEXPORT void _wrap_delete_TeuchosArrayInt(SwigClassWrapper const *farg1) { + Teuchos::Array< int > *arg1 = (Teuchos::Array< int > *) 0 ; + + SWIG_check_mutable_nonnull(*farg1, "Teuchos::Array< int > *", "TeuchosArrayInt", "Teuchos::Array< int >::~Array()", return ); + arg1 = static_cast< Teuchos::Array< int > * >(farg1->cptr); + { + // Make sure no unhandled exceptions exist before performing a new action + SWIG_check_unhandled_exception_impl("Teuchos::Array< int >::~Array()");; + try + { + // Attempt the wrapped function call + delete arg1; + } + catch (const std::range_error& e) + { + // Store a C++ exception + SWIG_exception_impl("Teuchos::Array< int >::~Array()", SWIG_IndexError, e.what(), return ); + } + catch (const std::exception& e) + { + // Store a C++ exception + SWIG_exception_impl("Teuchos::Array< int >::~Array()", SWIG_RuntimeError, e.what(), return ); + } + catch (...) + { + SWIG_exception_impl("Teuchos::Array< int >::~Array()", SWIG_UnknownError, "An unknown exception occurred", return ); + } + } + +} + + +SWIGEXPORT void _wrap_assign_TeuchosArrayInt(SwigClassWrapper * self, SwigClassWrapper const * other) { + typedef Teuchos::Array< int > swig_lhs_classtype; + SWIG_assign(swig_lhs_classtype, self, + swig_lhs_classtype, const_cast(other), + 0 | swig::IS_DESTR | swig::IS_COPY_CONSTR); +} + + +SWIGEXPORT SwigClassWrapper _wrap_new_TeuchosArrayDbl(SwigArrayWrapper *farg1) { + SwigClassWrapper fresult ; + Teuchos::ArrayView< double const > *arg1 = 0 ; + double const *tempbegin1 ; + Teuchos::ArrayView< double const > temparr1 ; + Teuchos::Array< double > *result = 0 ; + + tempbegin1 = static_cast(farg1->data); + temparr1 = Teuchos::ArrayView(tempbegin1, farg1->size); + arg1 = &temparr1; + { + // Make sure no unhandled exceptions exist before performing a new action + SWIG_check_unhandled_exception_impl("Teuchos::Array< double >::Array(Teuchos::ArrayView< double const > const &)");; + try + { + // Attempt the wrapped function call + result = (Teuchos::Array< double > *)new Teuchos::Array< double >((Teuchos::ArrayView< double const > const &)*arg1); + } + catch (const std::range_error& e) + { + // Store a C++ exception + SWIG_exception_impl("Teuchos::Array< double >::Array(Teuchos::ArrayView< double const > const &)", SWIG_IndexError, e.what(), return SwigClassWrapper_uninitialized()); + } + catch (const std::exception& e) + { + // Store a C++ exception + SWIG_exception_impl("Teuchos::Array< double >::Array(Teuchos::ArrayView< double const > const &)", SWIG_RuntimeError, e.what(), return SwigClassWrapper_uninitialized()); + } + catch (...) + { + SWIG_exception_impl("Teuchos::Array< double >::Array(Teuchos::ArrayView< double const > const &)", SWIG_UnknownError, "An unknown exception occurred", return SwigClassWrapper_uninitialized()); + } + } + fresult.cptr = result; + fresult.mem = (1 ? SWIG_MOVE : SWIG_REF); + return fresult; +} + + +SWIGEXPORT SwigArrayWrapper _wrap_TeuchosArrayDbl_view(SwigClassWrapper const *farg1) { + SwigArrayWrapper fresult ; + Teuchos::Array< double > *arg1 = (Teuchos::Array< double > *) 0 ; + Teuchos::ArrayView< double > result; + + SWIG_check_mutable_nonnull(*farg1, "Teuchos::Array< double > *", "TeuchosArrayDbl", "Teuchos::Array< double >::view()", return SwigArrayWrapper_uninitialized()); + arg1 = static_cast< Teuchos::Array< double > * >(farg1->cptr); + { + // Make sure no unhandled exceptions exist before performing a new action + SWIG_check_unhandled_exception_impl("Teuchos::Array< double >::view()");; + try + { + // Attempt the wrapped function call + result = Teuchos_Array_Sl_double_Sg__view(arg1); + } + catch (const std::range_error& e) + { + // Store a C++ exception + SWIG_exception_impl("Teuchos::Array< double >::view()", SWIG_IndexError, e.what(), return SwigArrayWrapper_uninitialized()); + } + catch (const std::exception& e) + { + // Store a C++ exception + SWIG_exception_impl("Teuchos::Array< double >::view()", SWIG_RuntimeError, e.what(), return SwigArrayWrapper_uninitialized()); + } + catch (...) + { + SWIG_exception_impl("Teuchos::Array< double >::view()", SWIG_UnknownError, "An unknown exception occurred", return SwigArrayWrapper_uninitialized()); + } + } + fresult.data = (&result)->getRawPtr(); + fresult.size = (&result)->size(); + return fresult; +} + + +SWIGEXPORT void _wrap_delete_TeuchosArrayDbl(SwigClassWrapper const *farg1) { + Teuchos::Array< double > *arg1 = (Teuchos::Array< double > *) 0 ; + + SWIG_check_mutable_nonnull(*farg1, "Teuchos::Array< double > *", "TeuchosArrayDbl", "Teuchos::Array< double >::~Array()", return ); + arg1 = static_cast< Teuchos::Array< double > * >(farg1->cptr); + { + // Make sure no unhandled exceptions exist before performing a new action + SWIG_check_unhandled_exception_impl("Teuchos::Array< double >::~Array()");; + try + { + // Attempt the wrapped function call + delete arg1; + } + catch (const std::range_error& e) + { + // Store a C++ exception + SWIG_exception_impl("Teuchos::Array< double >::~Array()", SWIG_IndexError, e.what(), return ); + } + catch (const std::exception& e) + { + // Store a C++ exception + SWIG_exception_impl("Teuchos::Array< double >::~Array()", SWIG_RuntimeError, e.what(), return ); + } + catch (...) + { + SWIG_exception_impl("Teuchos::Array< double >::~Array()", SWIG_UnknownError, "An unknown exception occurred", return ); + } + } + +} + + +SWIGEXPORT void _wrap_assign_TeuchosArrayDbl(SwigClassWrapper * self, SwigClassWrapper const * other) { + typedef Teuchos::Array< double > swig_lhs_classtype; + SWIG_assign(swig_lhs_classtype, self, + swig_lhs_classtype, const_cast(other), + 0 | swig::IS_DESTR | swig::IS_COPY_CONSTR); +} + + +SWIGEXPORT SwigClassWrapper _wrap_new_TeuchosArrayLongLong(SwigArrayWrapper *farg1) { + SwigClassWrapper fresult ; + Teuchos::ArrayView< long long const > *arg1 = 0 ; + long long const *tempbegin1 ; + Teuchos::ArrayView< long long const > temparr1 ; + Teuchos::Array< long long > *result = 0 ; + + tempbegin1 = static_cast(farg1->data); + temparr1 = Teuchos::ArrayView(tempbegin1, farg1->size); + arg1 = &temparr1; + { + // Make sure no unhandled exceptions exist before performing a new action + SWIG_check_unhandled_exception_impl("Teuchos::Array< long long >::Array(Teuchos::ArrayView< long long const > const &)");; + try + { + // Attempt the wrapped function call + result = (Teuchos::Array< long long > *)new Teuchos::Array< long long >((Teuchos::ArrayView< long long const > const &)*arg1); + } + catch (const std::range_error& e) + { + // Store a C++ exception + SWIG_exception_impl("Teuchos::Array< long long >::Array(Teuchos::ArrayView< long long const > const &)", SWIG_IndexError, e.what(), return SwigClassWrapper_uninitialized()); + } + catch (const std::exception& e) + { + // Store a C++ exception + SWIG_exception_impl("Teuchos::Array< long long >::Array(Teuchos::ArrayView< long long const > const &)", SWIG_RuntimeError, e.what(), return SwigClassWrapper_uninitialized()); + } + catch (...) + { + SWIG_exception_impl("Teuchos::Array< long long >::Array(Teuchos::ArrayView< long long const > const &)", SWIG_UnknownError, "An unknown exception occurred", return SwigClassWrapper_uninitialized()); + } + } + fresult.cptr = result; + fresult.mem = (1 ? SWIG_MOVE : SWIG_REF); + return fresult; +} + + +SWIGEXPORT SwigArrayWrapper _wrap_TeuchosArrayLongLong_view(SwigClassWrapper const *farg1) { + SwigArrayWrapper fresult ; + Teuchos::Array< long long > *arg1 = (Teuchos::Array< long long > *) 0 ; + Teuchos::ArrayView< long long > result; + + SWIG_check_mutable_nonnull(*farg1, "Teuchos::Array< long long > *", "TeuchosArrayLongLong", "Teuchos::Array< long long >::view()", return SwigArrayWrapper_uninitialized()); + arg1 = static_cast< Teuchos::Array< long long > * >(farg1->cptr); + { + // Make sure no unhandled exceptions exist before performing a new action + SWIG_check_unhandled_exception_impl("Teuchos::Array< long long >::view()");; + try + { + // Attempt the wrapped function call + result = Teuchos_Array_Sl_long_SS_long_Sg__view(arg1); + } + catch (const std::range_error& e) + { + // Store a C++ exception + SWIG_exception_impl("Teuchos::Array< long long >::view()", SWIG_IndexError, e.what(), return SwigArrayWrapper_uninitialized()); + } + catch (const std::exception& e) + { + // Store a C++ exception + SWIG_exception_impl("Teuchos::Array< long long >::view()", SWIG_RuntimeError, e.what(), return SwigArrayWrapper_uninitialized()); + } + catch (...) + { + SWIG_exception_impl("Teuchos::Array< long long >::view()", SWIG_UnknownError, "An unknown exception occurred", return SwigArrayWrapper_uninitialized()); + } + } + fresult.data = (&result)->getRawPtr(); + fresult.size = (&result)->size(); + return fresult; +} + + +SWIGEXPORT void _wrap_delete_TeuchosArrayLongLong(SwigClassWrapper const *farg1) { + Teuchos::Array< long long > *arg1 = (Teuchos::Array< long long > *) 0 ; + + SWIG_check_mutable_nonnull(*farg1, "Teuchos::Array< long long > *", "TeuchosArrayLongLong", "Teuchos::Array< long long >::~Array()", return ); + arg1 = static_cast< Teuchos::Array< long long > * >(farg1->cptr); + { + // Make sure no unhandled exceptions exist before performing a new action + SWIG_check_unhandled_exception_impl("Teuchos::Array< long long >::~Array()");; + try + { + // Attempt the wrapped function call + delete arg1; + } + catch (const std::range_error& e) + { + // Store a C++ exception + SWIG_exception_impl("Teuchos::Array< long long >::~Array()", SWIG_IndexError, e.what(), return ); + } + catch (const std::exception& e) + { + // Store a C++ exception + SWIG_exception_impl("Teuchos::Array< long long >::~Array()", SWIG_RuntimeError, e.what(), return ); + } + catch (...) + { + SWIG_exception_impl("Teuchos::Array< long long >::~Array()", SWIG_UnknownError, "An unknown exception occurred", return ); + } + } + +} + + +SWIGEXPORT void _wrap_assign_TeuchosArrayLongLong(SwigClassWrapper * self, SwigClassWrapper const * other) { + typedef Teuchos::Array< long long > swig_lhs_classtype; + SWIG_assign(swig_lhs_classtype, self, + swig_lhs_classtype, const_cast(other), + 0 | swig::IS_DESTR | swig::IS_COPY_CONSTR); +} + + SWIGEXPORT int _wrap_TeuchosComm_getRank(SwigClassWrapper const *farg1) { int fresult ; Teuchos::Comm< int > *arg1 = (Teuchos::Comm< int > *) 0 ; diff --git a/src/teuchos/test/CMakeLists.txt b/src/teuchos/test/CMakeLists.txt index 3218d425..c0121c47 100644 --- a/src/teuchos/test/CMakeLists.txt +++ b/src/teuchos/test/CMakeLists.txt @@ -8,6 +8,7 @@ ##---------------------------------------------------------------------------## SET(TESTS + test_teuchos_array.F90 test_teuchos_comm.F90 test_teuchos_plist.F90 ) diff --git a/src/teuchos/test/test_teuchos_array.F90 b/src/teuchos/test/test_teuchos_array.F90 new file mode 100644 index 00000000..7dacca8a --- /dev/null +++ b/src/teuchos/test/test_teuchos_array.F90 @@ -0,0 +1,43 @@ +!Copyright 2017-2018, UT-Battelle, LLC +! +!SPDX-License-Identifier: BSD-3-Clause +!License-Filename: LICENSE +program test_TeuchosArray +#include "ForTrilinosTeuchos_config.hpp" +#include "FortranTestUtilities.h" + use iso_fortran_env + use, intrinsic :: iso_c_binding + + use forteuchos + + implicit none + character(len=26), parameter :: FILENAME='test_teuchos_array.f90' + + + SETUP_TEST() + + ADD_SUBTEST_AND_RUN(TeuchosArray_Basic) + + TEARDOWN_TEST() +contains + + FORTRILINOS_UNIT_TEST(TeuchosArray_Basic) + + type(TeuchosArrayInt) :: arr + integer(C_INT), parameter, dimension(6) :: test_int = (/ -1, 1, 3, 3, 5, 7 /) + integer(C_INT), pointer, dimension(:) :: iptr => NULL() + + OUT0('Starting TeuchosArray_Basic!') + + arr = TeuchosArrayInt(test_int) + TEST_ASSERT(c_associated(arr%swigdata%cptr)) + + ! Get a view to the dataa + iptr => arr%view() + TEST_ASSERT(associated(iptr)) + TEST_ASSERT(size(iptr) == size(test_int)) + TEST_ASSERT(all(iptr == test_int)) + + END_FORTRILINOS_UNIT_TEST(TeuchosArray_Basic) + +end program test_TeuchosArray From dce87c0b9b25b30ed38f21f1c0064f0f1c9a1938 Mon Sep 17 00:00:00 2001 From: Seth R Johnson Date: Fri, 1 Feb 2019 17:26:21 -0500 Subject: [PATCH 07/40] Simplify MultiVector wrapping --- src/teuchos/src/Teuchos_ArrayView.i | 6 +- .../src/swig/forteuchosFORTRAN_wrap.cxx | 54 +- src/tpetra/src/Tpetra_CrsGraph.i | 2 +- src/tpetra/src/Tpetra_MultiVector.i | 89 +- src/tpetra/src/swig/fortpetra.F90 | 1130 +++++++------- src/tpetra/src/swig/fortpetraFORTRAN_wrap.cxx | 1344 +++++++++-------- src/tpetra/tutorials/MapsAndVectors.F90 | 2 +- 7 files changed, 1371 insertions(+), 1256 deletions(-) diff --git a/src/teuchos/src/Teuchos_ArrayView.i b/src/teuchos/src/Teuchos_ArrayView.i index 01bce98e..3b8d1fa2 100644 --- a/src/teuchos/src/Teuchos_ArrayView.i +++ b/src/teuchos/src/Teuchos_ArrayView.i @@ -29,7 +29,7 @@ class ArrayView } %typemap(out, noblock=1) ArrayView<_Tp> { - $result.data = $1.getRawPtr(); + $result.data = (void*)$1.getRawPtr(); $result.size = $1.size(); } @@ -52,3 +52,7 @@ class ArrayView %template() Teuchos::ArrayView; %template() Teuchos::ArrayView; %template() Teuchos::ArrayView; + +%template() Teuchos::ArrayView; +%template() Teuchos::ArrayView; +%template() Teuchos::ArrayView; diff --git a/src/teuchos/src/swig/forteuchosFORTRAN_wrap.cxx b/src/teuchos/src/swig/forteuchosFORTRAN_wrap.cxx index 40208382..dca4ad89 100644 --- a/src/teuchos/src/swig/forteuchosFORTRAN_wrap.cxx +++ b/src/teuchos/src/swig/forteuchosFORTRAN_wrap.cxx @@ -205,6 +205,21 @@ void SWIG_store_exception(const char* decl, int errcode, const char *msg); SWIG_store_exception(DECL, CODE, MSG); RETURNNULL; +namespace swig { + +enum AssignmentFlags { + IS_DESTR = 0x01, + IS_COPY_CONSTR = 0x02, + IS_COPY_ASSIGN = 0x04, + IS_MOVE_CONSTR = 0x08, + IS_MOVE_ASSIGN = 0x10 +}; + +template +struct assignment_flags; +} + + #define SWIG_check_mutable(SWIG_CLASS_WRAPPER, TYPENAME, FNAME, FUNCNAME, RETURNNULL) \ if ((SWIG_CLASS_WRAPPER).mem == SWIG_CREF) { \ SWIG_exception_impl(FUNCNAME, SWIG_TypeError, \ @@ -227,21 +242,6 @@ void SWIG_store_exception(const char* decl, int errcode, const char *msg); SWIG_check_mutable(SWIG_CLASS_WRAPPER, TYPENAME, FNAME, FUNCNAME, RETURNNULL); -namespace swig { - -enum AssignmentFlags { - IS_DESTR = 0x01, - IS_COPY_CONSTR = 0x02, - IS_COPY_ASSIGN = 0x04, - IS_MOVE_CONSTR = 0x08, - IS_MOVE_ASSIGN = 0x10 -}; - -template -struct assignment_flags; -} - - #define SWIG_assign(LEFTTYPE, LEFT, RIGHTTYPE, RIGHT, FLAGS) \ SWIG_assign_impl::value >(LEFT, RIGHT); @@ -274,6 +274,21 @@ struct assignment_flags; #define SWIG_as_voidptrptr(a) ((void)SWIG_as_voidptr(*a),reinterpret_cast< void** >(a)) +#include + + +namespace swig { +template +struct assignment_flags, Flags> { + enum { value = IS_DESTR | IS_COPY_CONSTR }; +}; +template +struct assignment_flags, Flags> { + enum { value = IS_DESTR | IS_COPY_CONSTR }; +}; +} + + #include @@ -344,9 +359,6 @@ SWIGINTERN Teuchos::ArrayView< int > Teuchos_Array_Sl_int_Sg__view(Teuchos::Arra return (*self)(); } -#include - - namespace swig { // Define our own switching struct to support pre-c++11 builds @@ -710,7 +722,7 @@ SWIGEXPORT SwigArrayWrapper _wrap_TeuchosArrayInt_view(SwigClassWrapper const *f SWIG_exception_impl("Teuchos::Array< int >::view()", SWIG_UnknownError, "An unknown exception occurred", return SwigArrayWrapper_uninitialized()); } } - fresult.data = (&result)->getRawPtr(); + fresult.data = (void*)(&result)->getRawPtr(); fresult.size = (&result)->size(); return fresult; } @@ -825,7 +837,7 @@ SWIGEXPORT SwigArrayWrapper _wrap_TeuchosArrayDbl_view(SwigClassWrapper const *f SWIG_exception_impl("Teuchos::Array< double >::view()", SWIG_UnknownError, "An unknown exception occurred", return SwigArrayWrapper_uninitialized()); } } - fresult.data = (&result)->getRawPtr(); + fresult.data = (void*)(&result)->getRawPtr(); fresult.size = (&result)->size(); return fresult; } @@ -940,7 +952,7 @@ SWIGEXPORT SwigArrayWrapper _wrap_TeuchosArrayLongLong_view(SwigClassWrapper con SWIG_exception_impl("Teuchos::Array< long long >::view()", SWIG_UnknownError, "An unknown exception occurred", return SwigArrayWrapper_uninitialized()); } } - fresult.data = (&result)->getRawPtr(); + fresult.data = (void*)(&result)->getRawPtr(); fresult.size = (&result)->size(); return fresult; } diff --git a/src/tpetra/src/Tpetra_CrsGraph.i b/src/tpetra/src/Tpetra_CrsGraph.i index 32f0f381..275df2ac 100644 --- a/src/tpetra/src/Tpetra_CrsGraph.i +++ b/src/tpetra/src/Tpetra_CrsGraph.i @@ -138,7 +138,7 @@ for (int i = 0; i < indicesView.size(); i++) indicesView[i]++; } - void getgblRowView(const GO gblRow, std::pair lclColInds) const { + void getGlobalRowView(const GO gblRow, std::pair lclColInds) const { Teuchos::ArrayView lclColIndsView = Teuchos::arrayView(lclColInds.first, lclColInds.second); self->getGlobalRowView(gblRow, lclColIndsView); } diff --git a/src/tpetra/src/Tpetra_MultiVector.i b/src/tpetra/src/Tpetra_MultiVector.i index 7165754d..2c1ef700 100644 --- a/src/tpetra/src/Tpetra_MultiVector.i +++ b/src/tpetra/src/Tpetra_MultiVector.i @@ -13,6 +13,11 @@ #include "Tpetra_MultiVector.hpp" %} +// Treat array RCP return values as array views (they won't reference count, +// though, of course) +%apply Teuchos::ArrayView { Teuchos::ArrayRCP }; +%apply Teuchos::ArrayView { Teuchos::ArrayRCP }; + // ======================================================================= // Postpone temporarily // ======================================================================= @@ -55,29 +60,7 @@ %ignore Tpetra::deep_copy; %ignore Tpetra::getMultiVectorWhichVectors; -// ======================================================================= -// Fix ±1 issues -// ======================================================================= -%typemap(in) size_t j %{$1 = *$input - 1;%} -%typemap(in) size_t col %{$1 = *$input - 1;%} -%typemap(in) int lclRow %{$1 = *$input - 1;%} /* int = LocalOrdinal */ - -// ======================================================================= -// Make interface more Fortran friendly -// ======================================================================= %extend Tpetra::MultiVector { - MultiVector (const Teuchos::RCP< const map_type > &map, std::pair A, const size_t LDA, const size_t NumVectors) { - Teuchos::ArrayView AView = Teuchos::arrayView(A.first, A.second); - return new Tpetra::MultiVector(map, AView, LDA, NumVectors); - } - std::pair getData(size_t j) const { - Teuchos::ArrayRCP a = self->getData(j); - return std::make_pair(a.get(), a.size()); - } - std::pair getDataNonConst(size_t j) { - Teuchos::ArrayRCP a = self->getDataNonConst(j); - return std::make_pair(a.get(), a.size()); - } Teuchos::RCP > subCopy(std::pair cols) const { Teuchos::Array colsArray(cols.second); for (int i = 0; i < colsArray.size(); i++) @@ -96,42 +79,7 @@ colsArray[i] = cols.first[i]-1; return self->subViewNonConst(colsArray); } - void dot( const Tpetra::MultiVector &A, std::pair dots) const { - Teuchos::ArrayView dotsView = Teuchos::arrayView(dots.first, dots.second); - return self->dot(A, dotsView); - } - void norm1(std::pair norms) const { - Teuchos::ArrayView normsView = Teuchos::arrayView(norms.first, norms.second); - return self->norm1(normsView); - } - void norm2(std::pair norms) const { - Teuchos::ArrayView normsView = Teuchos::arrayView(norms.first, norms.second); - return self->norm2(normsView); - } - void normInf(std::pair norms) const { - Teuchos::ArrayView normsView = Teuchos::arrayView(norms.first, norms.second); - return self->normInf(normsView); - } - void scale(std::pair alpha) { - Teuchos::ArrayView alphaView = Teuchos::arrayView(alpha.first, alpha.second); - self->scale(alphaView); - } - void meanValue(std::pair means) const { - Teuchos::ArrayView meansView = Teuchos::arrayView(means.first, means.second); - self->meanValue(meansView); - } - void get1dCopy(std::pair A, const size_t LDA) const { - Teuchos::ArrayView AView = Teuchos::arrayView(A.first, A.second); - self->get1dCopy(AView, LDA); - } - std::pair get1dView() const { - auto a = self->get1dView(); - return std::make_pair(a.getRawPtr(), a.size()); - } - std::pair get1dViewNonConst() { - auto a = self->get1dViewNonConst(); - return std::make_pair(a.getRawPtr(), a.size()); - } + void doImport (const Tpetra::MultiVector &source, const Tpetra::Import< LO, GO, NO > &importer, CombineMode CM) { self->doImport(source, importer, CM); } @@ -144,25 +92,17 @@ void doExport (const Tpetra::MultiVector &source, const Tpetra::Import< LO, GO, NO > &importer, CombineMode CM) { self->doExport(source, importer, CM); } - Teuchos::RCP > getMap() const { - return self->getMap(); - } } -%ignore Tpetra::MultiVector::MultiVector (const Teuchos::RCP< const map_type > &map, const Teuchos::ArrayView< const Scalar > &A, const size_t LDA, const size_t NumVectors); + %ignore Tpetra::MultiVector::subCopy(const Teuchos::ArrayView< const size_t > &cols) const; %ignore Tpetra::MultiVector::subView(const Teuchos::ArrayView< const size_t > &cols) const; %ignore Tpetra::MultiVector::subViewNonConst(const Teuchos::ArrayView< const size_t > &cols); -%ignore Tpetra::MultiVector::dot; -%ignore Tpetra::MultiVector::norm1; -%ignore Tpetra::MultiVector::norm2; -%ignore Tpetra::MultiVector::normInf; -%ignore Tpetra::MultiVector::meanValue; -%ignore Tpetra::MultiVector::scale(const Teuchos::ArrayView< const Scalar > &alpha); -%ignore Tpetra::MultiVector::getData; -%ignore Tpetra::MultiVector::getDataNonConst; -%ignore Tpetra::MultiVector::get1dCopy; -%ignore Tpetra::MultiVector::get1dView; -%ignore Tpetra::MultiVector::get1dViewNonConst; + +// Fix ±1 issues +// ======================================================================= +%typemap(in) size_t j %{$1 = *$input - 1;%} +%typemap(in) size_t col %{$1 = *$input - 1;%} +%typemap(in) int lclRow %{$1 = *$input - 1;%} /* int = LocalOrdinal */ /* Include the multivector *before* the RCP declaration so that * SWIG becomes aware of the default template arguments */ @@ -170,3 +110,6 @@ %teuchos_rcp(Tpetra::MultiVector) %template(TpetraMultiVector) Tpetra::MultiVector; + +%clear Teuchos::ArrayRCP; +%clear Teuchos::ArrayRCP; diff --git a/src/tpetra/src/swig/fortpetra.F90 b/src/tpetra/src/swig/fortpetra.F90 index 975bb2c7..399f0cde 100644 --- a/src/tpetra/src/swig/fortpetra.F90 +++ b/src/tpetra/src/swig/fortpetra.F90 @@ -217,6 +217,9 @@ module fortpetra module procedure new_TpetraImport__SWIG_3 end interface integer, parameter, public :: SWIGTYPE_Teuchos__DataAccess = C_INT + type, public :: SWIGTYPE_Kokkos__ViewT_double_p_Kokkos__HostSpace_t + type(SwigClassWrapper), public :: swigdata + end type integer, parameter, public :: SWIGTYPE_Teuchos__ETransp = C_INT ! class Tpetra::MultiVector< SC,LO,GO,NO > type, public :: TpetraMultiVector @@ -235,20 +238,38 @@ module fortpetra procedure, private :: randomize__SWIG_1 => swigf_TpetraMultiVector_randomize__SWIG_1 procedure :: replaceMap => swigf_TpetraMultiVector_replaceMap procedure :: reduce => swigf_TpetraMultiVector_reduce + procedure :: subCopy => swigf_TpetraMultiVector_subCopy + procedure :: subView => swigf_TpetraMultiVector_subView + procedure :: subViewNonConst => swigf_TpetraMultiVector_subViewNonConst procedure :: offsetView => swigf_TpetraMultiVector_offsetView procedure :: offsetViewNonConst => swigf_TpetraMultiVector_offsetViewNonConst + procedure :: getData => swigf_TpetraMultiVector_getData + procedure :: getDataNonConst => swigf_TpetraMultiVector_getDataNonConst + procedure :: get1dCopy => swigf_TpetraMultiVector_get1dCopy + procedure :: get1dView => swigf_TpetraMultiVector_get1dView + procedure :: get1dViewNonConst => swigf_TpetraMultiVector_get1dViewNonConst procedure :: sync_host => swigf_TpetraMultiVector_sync_host procedure :: sync_device => swigf_TpetraMultiVector_sync_device procedure :: need_sync_host => swigf_TpetraMultiVector_need_sync_host procedure :: need_sync_device => swigf_TpetraMultiVector_need_sync_device procedure :: modify_device => swigf_TpetraMultiVector_modify_device procedure :: modify_host => swigf_TpetraMultiVector_modify_host + procedure, private :: dot__SWIG_0 => swigf_TpetraMultiVector_dot__SWIG_0 + procedure, private :: dot__SWIG_3 => swigf_TpetraMultiVector_dot__SWIG_3 procedure :: abs => swigf_TpetraMultiVector_abs procedure :: reciprocal => swigf_TpetraMultiVector_reciprocal procedure, private :: scale__SWIG_0 => swigf_TpetraMultiVector_scale__SWIG_0 procedure, private :: scale__SWIG_1 => swigf_TpetraMultiVector_scale__SWIG_1 + procedure, private :: scale__SWIG_2 => swigf_TpetraMultiVector_scale__SWIG_2 procedure, private :: update__SWIG_0 => swigf_TpetraMultiVector_update__SWIG_0 procedure, private :: update__SWIG_1 => swigf_TpetraMultiVector_update__SWIG_1 + procedure, private :: norm1__SWIG_1 => swigf_TpetraMultiVector_norm1__SWIG_1 + procedure, private :: norm1__SWIG_3 => swigf_TpetraMultiVector_norm1__SWIG_3 + procedure, private :: norm2__SWIG_1 => swigf_TpetraMultiVector_norm2__SWIG_1 + procedure, private :: norm2__SWIG_3 => swigf_TpetraMultiVector_norm2__SWIG_3 + procedure, private :: normInf__SWIG_1 => swigf_TpetraMultiVector_normInf__SWIG_1 + procedure, private :: normInf__SWIG_3 => swigf_TpetraMultiVector_normInf__SWIG_3 + procedure :: meanValue => swigf_TpetraMultiVector_meanValue procedure :: multiply => swigf_TpetraMultiVector_multiply procedure :: getNumVectors => swigf_TpetraMultiVector_getNumVectors procedure :: getLocalLength => swigf_TpetraMultiVector_getLocalLength @@ -260,33 +281,22 @@ module fortpetra procedure :: setCopyOrView => swigf_TpetraMultiVector_setCopyOrView procedure :: getCopyOrView => swigf_TpetraMultiVector_getCopyOrView procedure :: isSameSize => swigf_TpetraMultiVector_isSameSize - procedure :: getData => swigf_TpetraMultiVector_getData - procedure :: getDataNonConst => swigf_TpetraMultiVector_getDataNonConst - procedure :: subCopy => swigf_TpetraMultiVector_subCopy - procedure :: subView => swigf_TpetraMultiVector_subView - procedure :: subViewNonConst => swigf_TpetraMultiVector_subViewNonConst - procedure :: dot => swigf_TpetraMultiVector_dot - procedure :: norm1 => swigf_TpetraMultiVector_norm1 - procedure :: norm2 => swigf_TpetraMultiVector_norm2 - procedure :: normInf => swigf_TpetraMultiVector_normInf - procedure, private :: scale__SWIG_2 => swigf_TpetraMultiVector_scale__SWIG_2 - procedure :: meanValue => swigf_TpetraMultiVector_meanValue - procedure :: get1dCopy => swigf_TpetraMultiVector_get1dCopy - procedure :: get1dView => swigf_TpetraMultiVector_get1dView - procedure :: get1dViewNonConst => swigf_TpetraMultiVector_get1dViewNonConst procedure, private :: doImport__SWIG_0 => swigf_TpetraMultiVector_doImport__SWIG_0 procedure, private :: doImport__SWIG_1 => swigf_TpetraMultiVector_doImport__SWIG_1 procedure, private :: doExport__SWIG_0 => swigf_TpetraMultiVector_doExport__SWIG_0 procedure, private :: doExport__SWIG_1 => swigf_TpetraMultiVector_doExport__SWIG_1 - procedure :: getMap => swigf_TpetraMultiVector_getMap procedure, private :: swigf_assignment_TpetraMultiVector generic :: assignment(=) => swigf_assignment_TpetraMultiVector generic :: randomize => randomize__SWIG_0, randomize__SWIG_1 + generic :: normInf => normInf__SWIG_1, normInf__SWIG_3 generic :: doImport => doImport__SWIG_0, doImport__SWIG_1 generic :: sumIntoGlobalValue => sumIntoGlobalValue__SWIG_0, sumIntoGlobalValue__SWIG_1 generic :: sumIntoLocalValue => sumIntoLocalValue__SWIG_0, sumIntoLocalValue__SWIG_1 + generic :: dot => dot__SWIG_0, dot__SWIG_3 + generic :: norm1 => norm1__SWIG_1, norm1__SWIG_3 generic :: doExport => doExport__SWIG_0, doExport__SWIG_1 generic :: scale => scale__SWIG_0, scale__SWIG_1, scale__SWIG_2 + generic :: norm2 => norm2__SWIG_1, norm2__SWIG_3 generic :: update => update__SWIG_0, update__SWIG_1 end type TpetraMultiVector interface TpetraMultiVector @@ -295,7 +305,7 @@ module fortpetra module procedure new_TpetraMultiVector__SWIG_2 module procedure new_TpetraMultiVector__SWIG_3 module procedure new_TpetraMultiVector__SWIG_4 - module procedure new_TpetraMultiVector__SWIG_6 + module procedure new_TpetraMultiVector__SWIG_5 module procedure new_TpetraMultiVector__SWIG_7 module procedure new_TpetraMultiVector__SWIG_8 end interface @@ -436,7 +446,7 @@ module fortpetra procedure :: insertLocalIndices => swigf_TpetraCrsGraph_insertLocalIndices procedure :: getGlobalRowCopy => swigf_TpetraCrsGraph_getGlobalRowCopy procedure :: getLocalRowCopy => swigf_TpetraCrsGraph_getLocalRowCopy - procedure :: getgblRowView => swigf_TpetraCrsGraph_getgblRowView + procedure :: getGlobalRowView => swigf_TpetraCrsGraph_getGlobalRowView procedure :: setAllIndices => swigf_TpetraCrsGraph_setAllIndices procedure :: getNodeRowPtrs => swigf_TpetraCrsGraph_getNodeRowPtrs procedure :: getNodePackedIndices => swigf_TpetraCrsGraph_getNodePackedIndices @@ -1367,24 +1377,37 @@ function swigc_new_TpetraMultiVector__SWIG_4(farg1, farg2) & type(SwigClassWrapper) :: fresult end function -function swigc_new_TpetraMultiVector__SWIG_6(farg1, farg2, farg3) & -bind(C, name="_wrap_new_TpetraMultiVector__SWIG_6") & +function swigc_new_TpetraMultiVector__SWIG_5(farg1, farg2, farg3, farg4) & +bind(C, name="_wrap_new_TpetraMultiVector__SWIG_5") & result(fresult) use, intrinsic :: ISO_C_BINDING import :: swigclasswrapper +import :: swigarraywrapper type(SwigClassWrapper) :: farg1 -type(SwigClassWrapper) :: farg2 +type(SwigArrayWrapper) :: farg2 integer(C_SIZE_T), intent(in) :: farg3 +integer(C_SIZE_T), intent(in) :: farg4 type(SwigClassWrapper) :: fresult end function -function swigc_new_TpetraMultiVector__SWIG_7(farg1, farg2) & +function swigc_new_TpetraMultiVector__SWIG_7(farg1, farg2, farg3) & bind(C, name="_wrap_new_TpetraMultiVector__SWIG_7") & result(fresult) use, intrinsic :: ISO_C_BINDING import :: swigclasswrapper type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 +integer(C_SIZE_T), intent(in) :: farg3 +type(SwigClassWrapper) :: fresult +end function + +function swigc_new_TpetraMultiVector__SWIG_8(farg1, farg2) & +bind(C, name="_wrap_new_TpetraMultiVector__SWIG_8") & +result(fresult) +use, intrinsic :: ISO_C_BINDING +import :: swigclasswrapper +type(SwigClassWrapper) :: farg1 +type(SwigClassWrapper) :: farg2 type(SwigClassWrapper) :: fresult end function @@ -1504,6 +1527,39 @@ subroutine swigc_TpetraMultiVector_reduce(farg1) & type(SwigClassWrapper) :: farg1 end subroutine +function swigc_TpetraMultiVector_subCopy(farg1, farg2) & +bind(C, name="_wrap_TpetraMultiVector_subCopy") & +result(fresult) +use, intrinsic :: ISO_C_BINDING +import :: swigclasswrapper +import :: swigarraywrapper +type(SwigClassWrapper) :: farg1 +type(SwigArrayWrapper) :: farg2 +type(SwigClassWrapper) :: fresult +end function + +function swigc_TpetraMultiVector_subView(farg1, farg2) & +bind(C, name="_wrap_TpetraMultiVector_subView") & +result(fresult) +use, intrinsic :: ISO_C_BINDING +import :: swigclasswrapper +import :: swigarraywrapper +type(SwigClassWrapper) :: farg1 +type(SwigArrayWrapper) :: farg2 +type(SwigClassWrapper) :: fresult +end function + +function swigc_TpetraMultiVector_subViewNonConst(farg1, farg2) & +bind(C, name="_wrap_TpetraMultiVector_subViewNonConst") & +result(fresult) +use, intrinsic :: ISO_C_BINDING +import :: swigclasswrapper +import :: swigarraywrapper +type(SwigClassWrapper) :: farg1 +type(SwigArrayWrapper) :: farg2 +type(SwigClassWrapper) :: fresult +end function + function swigc_TpetraMultiVector_offsetView(farg1, farg2, farg3) & bind(C, name="_wrap_TpetraMultiVector_offsetView") & result(fresult) @@ -1526,6 +1582,58 @@ function swigc_TpetraMultiVector_offsetViewNonConst(farg1, farg2, farg3) & type(SwigClassWrapper) :: fresult end function +function swigc_TpetraMultiVector_getData(farg1, farg2) & +bind(C, name="_wrap_TpetraMultiVector_getData") & +result(fresult) +use, intrinsic :: ISO_C_BINDING +import :: swigarraywrapper +import :: swigclasswrapper +type(SwigClassWrapper) :: farg1 +integer(C_SIZE_T), intent(in) :: farg2 +type(SwigArrayWrapper) :: fresult +end function + +function swigc_TpetraMultiVector_getDataNonConst(farg1, farg2) & +bind(C, name="_wrap_TpetraMultiVector_getDataNonConst") & +result(fresult) +use, intrinsic :: ISO_C_BINDING +import :: swigarraywrapper +import :: swigclasswrapper +type(SwigClassWrapper) :: farg1 +integer(C_SIZE_T), intent(in) :: farg2 +type(SwigArrayWrapper) :: fresult +end function + +subroutine swigc_TpetraMultiVector_get1dCopy(farg1, farg2, farg3) & +bind(C, name="_wrap_TpetraMultiVector_get1dCopy") +use, intrinsic :: ISO_C_BINDING +import :: swigclasswrapper +import :: swigarraywrapper +type(SwigClassWrapper) :: farg1 +type(SwigArrayWrapper) :: farg2 +integer(C_SIZE_T), intent(in) :: farg3 +end subroutine + +function swigc_TpetraMultiVector_get1dView(farg1) & +bind(C, name="_wrap_TpetraMultiVector_get1dView") & +result(fresult) +use, intrinsic :: ISO_C_BINDING +import :: swigarraywrapper +import :: swigclasswrapper +type(SwigClassWrapper) :: farg1 +type(SwigArrayWrapper) :: fresult +end function + +function swigc_TpetraMultiVector_get1dViewNonConst(farg1) & +bind(C, name="_wrap_TpetraMultiVector_get1dViewNonConst") & +result(fresult) +use, intrinsic :: ISO_C_BINDING +import :: swigarraywrapper +import :: swigclasswrapper +type(SwigClassWrapper) :: farg1 +type(SwigArrayWrapper) :: fresult +end function + subroutine swigc_TpetraMultiVector_sync_host(farg1) & bind(C, name="_wrap_TpetraMultiVector_sync_host") use, intrinsic :: ISO_C_BINDING @@ -1572,6 +1680,25 @@ subroutine swigc_TpetraMultiVector_modify_host(farg1) & type(SwigClassWrapper) :: farg1 end subroutine +subroutine swigc_TpetraMultiVector_dot__SWIG_0(farg1, farg2, farg3) & +bind(C, name="_wrap_TpetraMultiVector_dot__SWIG_0") +use, intrinsic :: ISO_C_BINDING +import :: swigclasswrapper +import :: swigarraywrapper +type(SwigClassWrapper) :: farg1 +type(SwigClassWrapper) :: farg2 +type(SwigArrayWrapper) :: farg3 +end subroutine + +subroutine swigc_TpetraMultiVector_dot__SWIG_3(farg1, farg2, farg3) & +bind(C, name="_wrap_TpetraMultiVector_dot__SWIG_3") +use, intrinsic :: ISO_C_BINDING +import :: swigclasswrapper +type(SwigClassWrapper) :: farg1 +type(SwigClassWrapper) :: farg2 +type(SwigClassWrapper) :: farg3 +end subroutine + subroutine swigc_TpetraMultiVector_abs(farg1, farg2) & bind(C, name="_wrap_TpetraMultiVector_abs") use, intrinsic :: ISO_C_BINDING @@ -1596,10 +1723,19 @@ subroutine swigc_TpetraMultiVector_scale__SWIG_0(farg1, farg2) & real(C_DOUBLE), intent(in) :: farg2 end subroutine -subroutine swigc_TpetraMultiVector_scale__SWIG_1(farg1, farg2, farg3) & +subroutine swigc_TpetraMultiVector_scale__SWIG_1(farg1, farg2) & bind(C, name="_wrap_TpetraMultiVector_scale__SWIG_1") use, intrinsic :: ISO_C_BINDING import :: swigclasswrapper +import :: swigarraywrapper +type(SwigClassWrapper) :: farg1 +type(SwigArrayWrapper) :: farg2 +end subroutine + +subroutine swigc_TpetraMultiVector_scale__SWIG_2(farg1, farg2, farg3) & +bind(C, name="_wrap_TpetraMultiVector_scale__SWIG_2") +use, intrinsic :: ISO_C_BINDING +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 real(C_DOUBLE), intent(in) :: farg2 type(SwigClassWrapper) :: farg3 @@ -1627,6 +1763,66 @@ subroutine swigc_TpetraMultiVector_update__SWIG_1(farg1, farg2, farg3, farg4, fa real(C_DOUBLE), intent(in) :: farg6 end subroutine +subroutine swigc_TpetraMultiVector_norm1__SWIG_1(farg1, farg2) & +bind(C, name="_wrap_TpetraMultiVector_norm1__SWIG_1") +use, intrinsic :: ISO_C_BINDING +import :: swigclasswrapper +type(SwigClassWrapper) :: farg1 +type(SwigClassWrapper) :: farg2 +end subroutine + +subroutine swigc_TpetraMultiVector_norm1__SWIG_3(farg1, farg2) & +bind(C, name="_wrap_TpetraMultiVector_norm1__SWIG_3") +use, intrinsic :: ISO_C_BINDING +import :: swigclasswrapper +import :: swigarraywrapper +type(SwigClassWrapper) :: farg1 +type(SwigArrayWrapper) :: farg2 +end subroutine + +subroutine swigc_TpetraMultiVector_norm2__SWIG_1(farg1, farg2) & +bind(C, name="_wrap_TpetraMultiVector_norm2__SWIG_1") +use, intrinsic :: ISO_C_BINDING +import :: swigclasswrapper +type(SwigClassWrapper) :: farg1 +type(SwigClassWrapper) :: farg2 +end subroutine + +subroutine swigc_TpetraMultiVector_norm2__SWIG_3(farg1, farg2) & +bind(C, name="_wrap_TpetraMultiVector_norm2__SWIG_3") +use, intrinsic :: ISO_C_BINDING +import :: swigclasswrapper +import :: swigarraywrapper +type(SwigClassWrapper) :: farg1 +type(SwigArrayWrapper) :: farg2 +end subroutine + +subroutine swigc_TpetraMultiVector_normInf__SWIG_1(farg1, farg2) & +bind(C, name="_wrap_TpetraMultiVector_normInf__SWIG_1") +use, intrinsic :: ISO_C_BINDING +import :: swigclasswrapper +type(SwigClassWrapper) :: farg1 +type(SwigClassWrapper) :: farg2 +end subroutine + +subroutine swigc_TpetraMultiVector_normInf__SWIG_3(farg1, farg2) & +bind(C, name="_wrap_TpetraMultiVector_normInf__SWIG_3") +use, intrinsic :: ISO_C_BINDING +import :: swigclasswrapper +import :: swigarraywrapper +type(SwigClassWrapper) :: farg1 +type(SwigArrayWrapper) :: farg2 +end subroutine + +subroutine swigc_TpetraMultiVector_meanValue(farg1, farg2) & +bind(C, name="_wrap_TpetraMultiVector_meanValue") +use, intrinsic :: ISO_C_BINDING +import :: swigclasswrapper +import :: swigarraywrapper +type(SwigClassWrapper) :: farg1 +type(SwigArrayWrapper) :: farg2 +end subroutine + subroutine swigc_TpetraMultiVector_multiply(farg1, farg2, farg3, farg4, farg5, farg6, farg7) & bind(C, name="_wrap_TpetraMultiVector_multiply") use, intrinsic :: ISO_C_BINDING @@ -1730,207 +1926,45 @@ function swigc_TpetraMultiVector_isSameSize(farg1, farg2) & integer(C_INT) :: fresult end function -function swigc_new_TpetraMultiVector__SWIG_8(farg1, farg2, farg3, farg4) & -bind(C, name="_wrap_new_TpetraMultiVector__SWIG_8") & -result(fresult) -use, intrinsic :: ISO_C_BINDING -import :: swigclasswrapper -import :: swigarraywrapper -type(SwigClassWrapper) :: farg1 -type(SwigArrayWrapper) :: farg2 -integer(C_SIZE_T), intent(in) :: farg3 -integer(C_SIZE_T), intent(in) :: farg4 -type(SwigClassWrapper) :: fresult -end function - -function swigc_TpetraMultiVector_getData(farg1, farg2) & -bind(C, name="_wrap_TpetraMultiVector_getData") & -result(fresult) +subroutine swigc_TpetraMultiVector_doImport__SWIG_0(farg1, farg2, farg3, farg4) & +bind(C, name="_wrap_TpetraMultiVector_doImport__SWIG_0") use, intrinsic :: ISO_C_BINDING -import :: swigarraywrapper import :: swigclasswrapper type(SwigClassWrapper) :: farg1 -integer(C_SIZE_T), intent(in) :: farg2 -type(SwigArrayWrapper) :: fresult -end function +type(SwigClassWrapper) :: farg2 +type(SwigClassWrapper) :: farg3 +integer(C_INT), intent(in) :: farg4 +end subroutine -function swigc_TpetraMultiVector_getDataNonConst(farg1, farg2) & -bind(C, name="_wrap_TpetraMultiVector_getDataNonConst") & -result(fresult) +subroutine swigc_TpetraMultiVector_doImport__SWIG_1(farg1, farg2, farg3, farg4) & +bind(C, name="_wrap_TpetraMultiVector_doImport__SWIG_1") use, intrinsic :: ISO_C_BINDING -import :: swigarraywrapper import :: swigclasswrapper type(SwigClassWrapper) :: farg1 -integer(C_SIZE_T), intent(in) :: farg2 -type(SwigArrayWrapper) :: fresult -end function +type(SwigClassWrapper) :: farg2 +type(SwigClassWrapper) :: farg3 +integer(C_INT), intent(in) :: farg4 +end subroutine -function swigc_TpetraMultiVector_subCopy(farg1, farg2) & -bind(C, name="_wrap_TpetraMultiVector_subCopy") & -result(fresult) +subroutine swigc_TpetraMultiVector_doExport__SWIG_0(farg1, farg2, farg3, farg4) & +bind(C, name="_wrap_TpetraMultiVector_doExport__SWIG_0") use, intrinsic :: ISO_C_BINDING import :: swigclasswrapper -import :: swigarraywrapper type(SwigClassWrapper) :: farg1 -type(SwigArrayWrapper) :: farg2 -type(SwigClassWrapper) :: fresult -end function +type(SwigClassWrapper) :: farg2 +type(SwigClassWrapper) :: farg3 +integer(C_INT), intent(in) :: farg4 +end subroutine -function swigc_TpetraMultiVector_subView(farg1, farg2) & -bind(C, name="_wrap_TpetraMultiVector_subView") & -result(fresult) +subroutine swigc_TpetraMultiVector_doExport__SWIG_1(farg1, farg2, farg3, farg4) & +bind(C, name="_wrap_TpetraMultiVector_doExport__SWIG_1") use, intrinsic :: ISO_C_BINDING import :: swigclasswrapper -import :: swigarraywrapper type(SwigClassWrapper) :: farg1 -type(SwigArrayWrapper) :: farg2 -type(SwigClassWrapper) :: fresult -end function - -function swigc_TpetraMultiVector_subViewNonConst(farg1, farg2) & -bind(C, name="_wrap_TpetraMultiVector_subViewNonConst") & -result(fresult) -use, intrinsic :: ISO_C_BINDING -import :: swigclasswrapper -import :: swigarraywrapper -type(SwigClassWrapper) :: farg1 -type(SwigArrayWrapper) :: farg2 -type(SwigClassWrapper) :: fresult -end function - -subroutine swigc_TpetraMultiVector_dot(farg1, farg2, farg3) & -bind(C, name="_wrap_TpetraMultiVector_dot") -use, intrinsic :: ISO_C_BINDING -import :: swigclasswrapper -import :: swigarraywrapper -type(SwigClassWrapper) :: farg1 -type(SwigClassWrapper) :: farg2 -type(SwigArrayWrapper) :: farg3 -end subroutine - -subroutine swigc_TpetraMultiVector_norm1(farg1, farg2) & -bind(C, name="_wrap_TpetraMultiVector_norm1") -use, intrinsic :: ISO_C_BINDING -import :: swigclasswrapper -import :: swigarraywrapper -type(SwigClassWrapper) :: farg1 -type(SwigArrayWrapper) :: farg2 -end subroutine - -subroutine swigc_TpetraMultiVector_norm2(farg1, farg2) & -bind(C, name="_wrap_TpetraMultiVector_norm2") -use, intrinsic :: ISO_C_BINDING -import :: swigclasswrapper -import :: swigarraywrapper -type(SwigClassWrapper) :: farg1 -type(SwigArrayWrapper) :: farg2 -end subroutine - -subroutine swigc_TpetraMultiVector_normInf(farg1, farg2) & -bind(C, name="_wrap_TpetraMultiVector_normInf") -use, intrinsic :: ISO_C_BINDING -import :: swigclasswrapper -import :: swigarraywrapper -type(SwigClassWrapper) :: farg1 -type(SwigArrayWrapper) :: farg2 -end subroutine - -subroutine swigc_TpetraMultiVector_scale__SWIG_2(farg1, farg2) & -bind(C, name="_wrap_TpetraMultiVector_scale__SWIG_2") -use, intrinsic :: ISO_C_BINDING -import :: swigclasswrapper -import :: swigarraywrapper -type(SwigClassWrapper) :: farg1 -type(SwigArrayWrapper) :: farg2 -end subroutine - -subroutine swigc_TpetraMultiVector_meanValue(farg1, farg2) & -bind(C, name="_wrap_TpetraMultiVector_meanValue") -use, intrinsic :: ISO_C_BINDING -import :: swigclasswrapper -import :: swigarraywrapper -type(SwigClassWrapper) :: farg1 -type(SwigArrayWrapper) :: farg2 -end subroutine - -subroutine swigc_TpetraMultiVector_get1dCopy(farg1, farg2, farg3) & -bind(C, name="_wrap_TpetraMultiVector_get1dCopy") -use, intrinsic :: ISO_C_BINDING -import :: swigclasswrapper -import :: swigarraywrapper -type(SwigClassWrapper) :: farg1 -type(SwigArrayWrapper) :: farg2 -integer(C_SIZE_T), intent(in) :: farg3 -end subroutine - -function swigc_TpetraMultiVector_get1dView(farg1) & -bind(C, name="_wrap_TpetraMultiVector_get1dView") & -result(fresult) -use, intrinsic :: ISO_C_BINDING -import :: swigarraywrapper -import :: swigclasswrapper -type(SwigClassWrapper) :: farg1 -type(SwigArrayWrapper) :: fresult -end function - -function swigc_TpetraMultiVector_get1dViewNonConst(farg1) & -bind(C, name="_wrap_TpetraMultiVector_get1dViewNonConst") & -result(fresult) -use, intrinsic :: ISO_C_BINDING -import :: swigarraywrapper -import :: swigclasswrapper -type(SwigClassWrapper) :: farg1 -type(SwigArrayWrapper) :: fresult -end function - -subroutine swigc_TpetraMultiVector_doImport__SWIG_0(farg1, farg2, farg3, farg4) & -bind(C, name="_wrap_TpetraMultiVector_doImport__SWIG_0") -use, intrinsic :: ISO_C_BINDING -import :: swigclasswrapper -type(SwigClassWrapper) :: farg1 -type(SwigClassWrapper) :: farg2 -type(SwigClassWrapper) :: farg3 -integer(C_INT), intent(in) :: farg4 -end subroutine - -subroutine swigc_TpetraMultiVector_doImport__SWIG_1(farg1, farg2, farg3, farg4) & -bind(C, name="_wrap_TpetraMultiVector_doImport__SWIG_1") -use, intrinsic :: ISO_C_BINDING -import :: swigclasswrapper -type(SwigClassWrapper) :: farg1 -type(SwigClassWrapper) :: farg2 -type(SwigClassWrapper) :: farg3 -integer(C_INT), intent(in) :: farg4 -end subroutine - -subroutine swigc_TpetraMultiVector_doExport__SWIG_0(farg1, farg2, farg3, farg4) & -bind(C, name="_wrap_TpetraMultiVector_doExport__SWIG_0") -use, intrinsic :: ISO_C_BINDING -import :: swigclasswrapper -type(SwigClassWrapper) :: farg1 -type(SwigClassWrapper) :: farg2 -type(SwigClassWrapper) :: farg3 -integer(C_INT), intent(in) :: farg4 -end subroutine - -subroutine swigc_TpetraMultiVector_doExport__SWIG_1(farg1, farg2, farg3, farg4) & -bind(C, name="_wrap_TpetraMultiVector_doExport__SWIG_1") -use, intrinsic :: ISO_C_BINDING -import :: swigclasswrapper -type(SwigClassWrapper) :: farg1 -type(SwigClassWrapper) :: farg2 -type(SwigClassWrapper) :: farg3 -integer(C_INT), intent(in) :: farg4 -end subroutine - -function swigc_TpetraMultiVector_getMap(farg1) & -bind(C, name="_wrap_TpetraMultiVector_getMap") & -result(fresult) -use, intrinsic :: ISO_C_BINDING -import :: swigclasswrapper -type(SwigClassWrapper) :: farg1 -type(SwigClassWrapper) :: fresult -end function +type(SwigClassWrapper) :: farg2 +type(SwigClassWrapper) :: farg3 +integer(C_INT), intent(in) :: farg4 +end subroutine subroutine swigc_assignment_TpetraMultiVector(self, other) & bind(C, name="_wrap_assign_TpetraMultiVector") @@ -2990,8 +3024,8 @@ subroutine swigc_TpetraCrsGraph_getLocalRowCopy(farg1, farg2, farg3, farg4) & type(C_PTR), value :: farg4 end subroutine -subroutine swigc_TpetraCrsGraph_getgblRowView(farg1, farg2, farg3) & -bind(C, name="_wrap_TpetraCrsGraph_getgblRowView") +subroutine swigc_TpetraCrsGraph_getGlobalRowView(farg1, farg2, farg3) & +bind(C, name="_wrap_TpetraCrsGraph_getGlobalRowView") use, intrinsic :: ISO_C_BINDING import :: swigclasswrapper import :: swigarraywrapper @@ -5956,7 +5990,34 @@ function new_TpetraMultiVector__SWIG_4(source, copyorview) & self%swigdata = fresult end function -function new_TpetraMultiVector__SWIG_6(x, submap, offset) & +function new_TpetraMultiVector__SWIG_5(map, a, lda, numvectors) & +result(self) +use, intrinsic :: ISO_C_BINDING +type(TpetraMultiVector) :: self +class(TpetraMap), intent(in) :: map + +real(C_DOUBLE), dimension(:), target :: a +real(C_DOUBLE), pointer :: farg2_view +integer(C_SIZE_T), intent(in) :: lda +integer(C_SIZE_T), intent(in) :: numvectors + +type(SwigClassWrapper) :: fresult +type(SwigClassWrapper) :: farg1 +type(SwigArrayWrapper) :: farg2 +integer(C_SIZE_T) :: farg3 +integer(C_SIZE_T) :: farg4 + +farg1 = map%swigdata +farg2_view => a(1) +farg2%data = c_loc(farg2_view) +farg2%size = size(a) +farg3 = lda +farg4 = numvectors +fresult = swigc_new_TpetraMultiVector__SWIG_5(farg1, farg2, farg3, farg4) +self%swigdata = fresult +end function + +function new_TpetraMultiVector__SWIG_7(x, submap, offset) & result(self) use, intrinsic :: ISO_C_BINDING type(TpetraMultiVector) :: self @@ -5974,11 +6035,11 @@ function new_TpetraMultiVector__SWIG_6(x, submap, offset) & farg1 = x%swigdata farg2 = submap%swigdata farg3 = offset -fresult = swigc_new_TpetraMultiVector__SWIG_6(farg1, farg2, farg3) +fresult = swigc_new_TpetraMultiVector__SWIG_7(farg1, farg2, farg3) self%swigdata = fresult end function -function new_TpetraMultiVector__SWIG_7(x, submap) & +function new_TpetraMultiVector__SWIG_8(x, submap) & result(self) use, intrinsic :: ISO_C_BINDING type(TpetraMultiVector) :: self @@ -5992,7 +6053,7 @@ function new_TpetraMultiVector__SWIG_7(x, submap) & farg1 = x%swigdata farg2 = submap%swigdata -fresult = swigc_new_TpetraMultiVector__SWIG_7(farg1, farg2) +fresult = swigc_new_TpetraMultiVector__SWIG_8(farg1, farg2) self%swigdata = fresult end function @@ -6215,6 +6276,69 @@ subroutine swigf_TpetraMultiVector_reduce(self) call swigc_TpetraMultiVector_reduce(farg1) end subroutine +function swigf_TpetraMultiVector_subCopy(self, cols) & +result(swig_result) +use, intrinsic :: ISO_C_BINDING +type(TpetraMultiVector) :: swig_result +class(TpetraMultiVector), intent(in) :: self + +integer(C_LONG), dimension(:), target :: cols +integer(C_LONG), pointer :: farg2_view + +type(SwigClassWrapper) :: fresult +type(SwigClassWrapper) :: farg1 +type(SwigArrayWrapper) :: farg2 + +farg1 = self%swigdata +farg2_view => cols(1) +farg2%data = c_loc(farg2_view) +farg2%size = size(cols) +fresult = swigc_TpetraMultiVector_subCopy(farg1, farg2) +swig_result%swigdata = fresult +end function + +function swigf_TpetraMultiVector_subView(self, cols) & +result(swig_result) +use, intrinsic :: ISO_C_BINDING +type(TpetraMultiVector) :: swig_result +class(TpetraMultiVector), intent(in) :: self + +integer(C_LONG), dimension(:), target :: cols +integer(C_LONG), pointer :: farg2_view + +type(SwigClassWrapper) :: fresult +type(SwigClassWrapper) :: farg1 +type(SwigArrayWrapper) :: farg2 + +farg1 = self%swigdata +farg2_view => cols(1) +farg2%data = c_loc(farg2_view) +farg2%size = size(cols) +fresult = swigc_TpetraMultiVector_subView(farg1, farg2) +swig_result%swigdata = fresult +end function + +function swigf_TpetraMultiVector_subViewNonConst(self, cols) & +result(swig_result) +use, intrinsic :: ISO_C_BINDING +type(TpetraMultiVector) :: swig_result +class(TpetraMultiVector), intent(inout) :: self + +integer(C_LONG), dimension(:), target :: cols +integer(C_LONG), pointer :: farg2_view + +type(SwigClassWrapper) :: fresult +type(SwigClassWrapper) :: farg1 +type(SwigArrayWrapper) :: farg2 + +farg1 = self%swigdata +farg2_view => cols(1) +farg2%data = c_loc(farg2_view) +farg2%size = size(cols) +fresult = swigc_TpetraMultiVector_subViewNonConst(farg1, farg2) +swig_result%swigdata = fresult +end function + function swigf_TpetraMultiVector_offsetView(self, submap, offset) & result(swig_result) use, intrinsic :: ISO_C_BINDING @@ -6259,36 +6383,120 @@ function swigf_TpetraMultiVector_offsetViewNonConst(self, submap, offset) & swig_result%swigdata = fresult end function -subroutine swigf_TpetraMultiVector_sync_host(self) +function swigf_TpetraMultiVector_getData(self, j) & +result(swig_result) use, intrinsic :: ISO_C_BINDING -class(TpetraMultiVector), intent(inout) :: self +real(C_DOUBLE), dimension(:), pointer :: swig_result +class(TpetraMultiVector), intent(in) :: self + +integer(C_SIZE_T), intent(in) :: j +type(SwigArrayWrapper) :: fresult type(SwigClassWrapper) :: farg1 +integer(C_SIZE_T) :: farg2 farg1 = self%swigdata -call swigc_TpetraMultiVector_sync_host(farg1) -end subroutine +farg2 = j +fresult = swigc_TpetraMultiVector_getData(farg1, farg2) +call c_f_pointer(fresult%data, swig_result, [fresult%size]) +end function -subroutine swigf_TpetraMultiVector_sync_device(self) +function swigf_TpetraMultiVector_getDataNonConst(self, j) & +result(swig_result) use, intrinsic :: ISO_C_BINDING +real(C_DOUBLE), dimension(:), pointer :: swig_result class(TpetraMultiVector), intent(inout) :: self +integer(C_SIZE_T), intent(in) :: j + +type(SwigArrayWrapper) :: fresult type(SwigClassWrapper) :: farg1 +integer(C_SIZE_T) :: farg2 farg1 = self%swigdata -call swigc_TpetraMultiVector_sync_device(farg1) -end subroutine +farg2 = j +fresult = swigc_TpetraMultiVector_getDataNonConst(farg1, farg2) +call c_f_pointer(fresult%data, swig_result, [fresult%size]) +end function -function swigf_TpetraMultiVector_need_sync_host(self) & -result(swig_result) +subroutine swigf_TpetraMultiVector_get1dCopy(self, a, lda) use, intrinsic :: ISO_C_BINDING -logical :: swig_result class(TpetraMultiVector), intent(in) :: self -integer(C_INT) :: fresult -type(SwigClassWrapper) :: farg1 +real(C_DOUBLE), dimension(:), target :: a +real(C_DOUBLE), pointer :: farg2_view +integer(C_SIZE_T), intent(in) :: lda -farg1 = self%swigdata +type(SwigClassWrapper) :: farg1 +type(SwigArrayWrapper) :: farg2 +integer(C_SIZE_T) :: farg3 + +farg1 = self%swigdata +farg2_view => a(1) +farg2%data = c_loc(farg2_view) +farg2%size = size(a) +farg3 = lda +call swigc_TpetraMultiVector_get1dCopy(farg1, farg2, farg3) +end subroutine + +function swigf_TpetraMultiVector_get1dView(self) & +result(swig_result) +use, intrinsic :: ISO_C_BINDING +real(C_DOUBLE), dimension(:), pointer :: swig_result +class(TpetraMultiVector), intent(in) :: self + +type(SwigArrayWrapper) :: fresult +type(SwigClassWrapper) :: farg1 + +farg1 = self%swigdata +fresult = swigc_TpetraMultiVector_get1dView(farg1) +call c_f_pointer(fresult%data, swig_result, [fresult%size]) +end function + +function swigf_TpetraMultiVector_get1dViewNonConst(self) & +result(swig_result) +use, intrinsic :: ISO_C_BINDING +real(C_DOUBLE), dimension(:), pointer :: swig_result +class(TpetraMultiVector), intent(inout) :: self + +type(SwigArrayWrapper) :: fresult +type(SwigClassWrapper) :: farg1 + +farg1 = self%swigdata +fresult = swigc_TpetraMultiVector_get1dViewNonConst(farg1) +call c_f_pointer(fresult%data, swig_result, [fresult%size]) +end function + +subroutine swigf_TpetraMultiVector_sync_host(self) +use, intrinsic :: ISO_C_BINDING +class(TpetraMultiVector), intent(inout) :: self + +type(SwigClassWrapper) :: farg1 + +farg1 = self%swigdata +call swigc_TpetraMultiVector_sync_host(farg1) +end subroutine + +subroutine swigf_TpetraMultiVector_sync_device(self) +use, intrinsic :: ISO_C_BINDING +class(TpetraMultiVector), intent(inout) :: self + +type(SwigClassWrapper) :: farg1 + +farg1 = self%swigdata +call swigc_TpetraMultiVector_sync_device(farg1) +end subroutine + +function swigf_TpetraMultiVector_need_sync_host(self) & +result(swig_result) +use, intrinsic :: ISO_C_BINDING +logical :: swig_result +class(TpetraMultiVector), intent(in) :: self + +integer(C_INT) :: fresult +type(SwigClassWrapper) :: farg1 + +farg1 = self%swigdata fresult = swigc_TpetraMultiVector_need_sync_host(farg1) swig_result = SWIG_int_to_logical(fresult) end function @@ -6327,6 +6535,45 @@ subroutine swigf_TpetraMultiVector_modify_host(self) call swigc_TpetraMultiVector_modify_host(farg1) end subroutine +subroutine swigf_TpetraMultiVector_dot__SWIG_0(self, a, dots) +use, intrinsic :: ISO_C_BINDING +class(TpetraMultiVector), intent(in) :: self + +class(TpetraMultiVector), intent(in) :: a + +real(C_DOUBLE), dimension(:), target :: dots +real(C_DOUBLE), pointer :: farg3_view + +type(SwigClassWrapper) :: farg1 +type(SwigClassWrapper) :: farg2 +type(SwigArrayWrapper) :: farg3 + +farg1 = self%swigdata +farg2 = a%swigdata +farg3_view => dots(1) +farg3%data = c_loc(farg3_view) +farg3%size = size(dots) +call swigc_TpetraMultiVector_dot__SWIG_0(farg1, farg2, farg3) +end subroutine + +subroutine swigf_TpetraMultiVector_dot__SWIG_3(self, a, norms) +use, intrinsic :: ISO_C_BINDING +class(TpetraMultiVector), intent(in) :: self + +class(TpetraMultiVector), intent(in) :: a + +class(SWIGTYPE_Kokkos__ViewT_double_p_Kokkos__HostSpace_t), intent(in) :: norms + +type(SwigClassWrapper) :: farg1 +type(SwigClassWrapper) :: farg2 +type(SwigClassWrapper) :: farg3 + +farg1 = self%swigdata +farg2 = a%swigdata +farg3 = norms%swigdata +call swigc_TpetraMultiVector_dot__SWIG_3(farg1, farg2, farg3) +end subroutine + subroutine swigf_TpetraMultiVector_abs(self, a) use, intrinsic :: ISO_C_BINDING class(TpetraMultiVector), intent(inout) :: self @@ -6369,7 +6616,24 @@ subroutine swigf_TpetraMultiVector_scale__SWIG_0(self, alpha) call swigc_TpetraMultiVector_scale__SWIG_0(farg1, farg2) end subroutine -subroutine swigf_TpetraMultiVector_scale__SWIG_1(self, alpha, a) +subroutine swigf_TpetraMultiVector_scale__SWIG_1(self, alpha) +use, intrinsic :: ISO_C_BINDING +class(TpetraMultiVector), intent(inout) :: self + +real(C_DOUBLE), dimension(:), target :: alpha +real(C_DOUBLE), pointer :: farg2_view + +type(SwigClassWrapper) :: farg1 +type(SwigArrayWrapper) :: farg2 + +farg1 = self%swigdata +farg2_view => alpha(1) +farg2%data = c_loc(farg2_view) +farg2%size = size(alpha) +call swigc_TpetraMultiVector_scale__SWIG_1(farg1, farg2) +end subroutine + +subroutine swigf_TpetraMultiVector_scale__SWIG_2(self, alpha, a) use, intrinsic :: ISO_C_BINDING class(TpetraMultiVector), intent(inout) :: self @@ -6383,7 +6647,7 @@ subroutine swigf_TpetraMultiVector_scale__SWIG_1(self, alpha, a) farg1 = self%swigdata farg2 = alpha farg3 = a%swigdata -call swigc_TpetraMultiVector_scale__SWIG_1(farg1, farg2, farg3) +call swigc_TpetraMultiVector_scale__SWIG_2(farg1, farg2, farg3) end subroutine subroutine swigf_TpetraMultiVector_update__SWIG_0(self, alpha, a, beta) @@ -6435,6 +6699,116 @@ subroutine swigf_TpetraMultiVector_update__SWIG_1(self, alpha, a, beta, b, gamma call swigc_TpetraMultiVector_update__SWIG_1(farg1, farg2, farg3, farg4, farg5, farg6) end subroutine +subroutine swigf_TpetraMultiVector_norm1__SWIG_1(self, norms) +use, intrinsic :: ISO_C_BINDING +class(TpetraMultiVector), intent(in) :: self + +class(SWIGTYPE_Kokkos__ViewT_double_p_Kokkos__HostSpace_t), intent(in) :: norms + +type(SwigClassWrapper) :: farg1 +type(SwigClassWrapper) :: farg2 + +farg1 = self%swigdata +farg2 = norms%swigdata +call swigc_TpetraMultiVector_norm1__SWIG_1(farg1, farg2) +end subroutine + +subroutine swigf_TpetraMultiVector_norm1__SWIG_3(self, norms) +use, intrinsic :: ISO_C_BINDING +class(TpetraMultiVector), intent(in) :: self + +real(C_DOUBLE), dimension(:), target :: norms +real(C_DOUBLE), pointer :: farg2_view + +type(SwigClassWrapper) :: farg1 +type(SwigArrayWrapper) :: farg2 + +farg1 = self%swigdata +farg2_view => norms(1) +farg2%data = c_loc(farg2_view) +farg2%size = size(norms) +call swigc_TpetraMultiVector_norm1__SWIG_3(farg1, farg2) +end subroutine + +subroutine swigf_TpetraMultiVector_norm2__SWIG_1(self, norms) +use, intrinsic :: ISO_C_BINDING +class(TpetraMultiVector), intent(in) :: self + +class(SWIGTYPE_Kokkos__ViewT_double_p_Kokkos__HostSpace_t), intent(in) :: norms + +type(SwigClassWrapper) :: farg1 +type(SwigClassWrapper) :: farg2 + +farg1 = self%swigdata +farg2 = norms%swigdata +call swigc_TpetraMultiVector_norm2__SWIG_1(farg1, farg2) +end subroutine + +subroutine swigf_TpetraMultiVector_norm2__SWIG_3(self, norms) +use, intrinsic :: ISO_C_BINDING +class(TpetraMultiVector), intent(in) :: self + +real(C_DOUBLE), dimension(:), target :: norms +real(C_DOUBLE), pointer :: farg2_view + +type(SwigClassWrapper) :: farg1 +type(SwigArrayWrapper) :: farg2 + +farg1 = self%swigdata +farg2_view => norms(1) +farg2%data = c_loc(farg2_view) +farg2%size = size(norms) +call swigc_TpetraMultiVector_norm2__SWIG_3(farg1, farg2) +end subroutine + +subroutine swigf_TpetraMultiVector_normInf__SWIG_1(self, norms) +use, intrinsic :: ISO_C_BINDING +class(TpetraMultiVector), intent(in) :: self + +class(SWIGTYPE_Kokkos__ViewT_double_p_Kokkos__HostSpace_t), intent(in) :: norms + +type(SwigClassWrapper) :: farg1 +type(SwigClassWrapper) :: farg2 + +farg1 = self%swigdata +farg2 = norms%swigdata +call swigc_TpetraMultiVector_normInf__SWIG_1(farg1, farg2) +end subroutine + +subroutine swigf_TpetraMultiVector_normInf__SWIG_3(self, norms) +use, intrinsic :: ISO_C_BINDING +class(TpetraMultiVector), intent(in) :: self + +real(C_DOUBLE), dimension(:), target :: norms +real(C_DOUBLE), pointer :: farg2_view + +type(SwigClassWrapper) :: farg1 +type(SwigArrayWrapper) :: farg2 + +farg1 = self%swigdata +farg2_view => norms(1) +farg2%data = c_loc(farg2_view) +farg2%size = size(norms) +call swigc_TpetraMultiVector_normInf__SWIG_3(farg1, farg2) +end subroutine + +subroutine swigf_TpetraMultiVector_meanValue(self, means) +use, intrinsic :: ISO_C_BINDING +class(TpetraMultiVector), intent(in) :: self + +real(C_DOUBLE), dimension(:), target :: means +real(C_DOUBLE), pointer :: farg2_view + +type(SwigClassWrapper) :: farg1 +type(SwigArrayWrapper) :: farg2 + +farg1 = self%swigdata +farg2_view => means(1) +farg2%data = c_loc(farg2_view) +farg2%size = size(means) +call swigc_TpetraMultiVector_meanValue(farg1, farg2) +end subroutine + subroutine swigf_TpetraMultiVector_multiply(self, transa, transb, alpha, a, b, beta) use, intrinsic :: ISO_C_BINDING class(TpetraMultiVector), intent(inout) :: self @@ -6611,286 +6985,6 @@ function swigf_TpetraMultiVector_isSameSize(self, vec) & swig_result = SWIG_int_to_logical(fresult) end function -function new_TpetraMultiVector__SWIG_8(map, a, lda, numvectors) & -result(self) -use, intrinsic :: ISO_C_BINDING -type(TpetraMultiVector) :: self -class(TpetraMap), intent(in) :: map - -real(C_DOUBLE), dimension(:), target :: a -real(C_DOUBLE), pointer :: farg2_view -integer(C_SIZE_T), intent(in) :: lda -integer(C_SIZE_T), intent(in) :: numvectors - -type(SwigClassWrapper) :: fresult -type(SwigClassWrapper) :: farg1 -type(SwigArrayWrapper) :: farg2 -integer(C_SIZE_T) :: farg3 -integer(C_SIZE_T) :: farg4 - -farg1 = map%swigdata -farg2_view => a(1) -farg2%data = c_loc(farg2_view) -farg2%size = size(a) -farg3 = lda -farg4 = numvectors -fresult = swigc_new_TpetraMultiVector__SWIG_8(farg1, farg2, farg3, farg4) -self%swigdata = fresult -end function - -function swigf_TpetraMultiVector_getData(self, j) & -result(swig_result) -use, intrinsic :: ISO_C_BINDING -real(C_DOUBLE), dimension(:), pointer :: swig_result -class(TpetraMultiVector), intent(in) :: self - -integer(C_SIZE_T), intent(in) :: j - -type(SwigArrayWrapper) :: fresult -type(SwigClassWrapper) :: farg1 -integer(C_SIZE_T) :: farg2 - -farg1 = self%swigdata -farg2 = j -fresult = swigc_TpetraMultiVector_getData(farg1, farg2) -call c_f_pointer(fresult%data, swig_result, [fresult%size]) -end function - -function swigf_TpetraMultiVector_getDataNonConst(self, j) & -result(swig_result) -use, intrinsic :: ISO_C_BINDING -real(C_DOUBLE), dimension(:), pointer :: swig_result -class(TpetraMultiVector), intent(inout) :: self - -integer(C_SIZE_T), intent(in) :: j - -type(SwigArrayWrapper) :: fresult -type(SwigClassWrapper) :: farg1 -integer(C_SIZE_T) :: farg2 - -farg1 = self%swigdata -farg2 = j -fresult = swigc_TpetraMultiVector_getDataNonConst(farg1, farg2) -call c_f_pointer(fresult%data, swig_result, [fresult%size]) -end function - -function swigf_TpetraMultiVector_subCopy(self, cols) & -result(swig_result) -use, intrinsic :: ISO_C_BINDING -type(TpetraMultiVector) :: swig_result -class(TpetraMultiVector), intent(in) :: self - -integer(C_SIZE_T), dimension(:), target :: cols -integer(C_SIZE_T), pointer :: farg2_view - -type(SwigClassWrapper) :: fresult -type(SwigClassWrapper) :: farg1 -type(SwigArrayWrapper) :: farg2 - -farg1 = self%swigdata -farg2_view => cols(1) -farg2%data = c_loc(farg2_view) -farg2%size = size(cols) -fresult = swigc_TpetraMultiVector_subCopy(farg1, farg2) -swig_result%swigdata = fresult -end function - -function swigf_TpetraMultiVector_subView(self, cols) & -result(swig_result) -use, intrinsic :: ISO_C_BINDING -type(TpetraMultiVector) :: swig_result -class(TpetraMultiVector), intent(in) :: self - -integer(C_SIZE_T), dimension(:), target :: cols -integer(C_SIZE_T), pointer :: farg2_view - -type(SwigClassWrapper) :: fresult -type(SwigClassWrapper) :: farg1 -type(SwigArrayWrapper) :: farg2 - -farg1 = self%swigdata -farg2_view => cols(1) -farg2%data = c_loc(farg2_view) -farg2%size = size(cols) -fresult = swigc_TpetraMultiVector_subView(farg1, farg2) -swig_result%swigdata = fresult -end function - -function swigf_TpetraMultiVector_subViewNonConst(self, cols) & -result(swig_result) -use, intrinsic :: ISO_C_BINDING -type(TpetraMultiVector) :: swig_result -class(TpetraMultiVector), intent(inout) :: self - -integer(C_SIZE_T), dimension(:), target :: cols -integer(C_SIZE_T), pointer :: farg2_view - -type(SwigClassWrapper) :: fresult -type(SwigClassWrapper) :: farg1 -type(SwigArrayWrapper) :: farg2 - -farg1 = self%swigdata -farg2_view => cols(1) -farg2%data = c_loc(farg2_view) -farg2%size = size(cols) -fresult = swigc_TpetraMultiVector_subViewNonConst(farg1, farg2) -swig_result%swigdata = fresult -end function - -subroutine swigf_TpetraMultiVector_dot(self, a, dots) -use, intrinsic :: ISO_C_BINDING -class(TpetraMultiVector), intent(in) :: self - -class(TpetraMultiVector), intent(in) :: a - -real(C_DOUBLE), dimension(:), target :: dots -real(C_DOUBLE), pointer :: farg3_view - -type(SwigClassWrapper) :: farg1 -type(SwigClassWrapper) :: farg2 -type(SwigArrayWrapper) :: farg3 - -farg1 = self%swigdata -farg2 = a%swigdata -farg3_view => dots(1) -farg3%data = c_loc(farg3_view) -farg3%size = size(dots) -call swigc_TpetraMultiVector_dot(farg1, farg2, farg3) -end subroutine - -subroutine swigf_TpetraMultiVector_norm1(self, norms) -use, intrinsic :: ISO_C_BINDING -class(TpetraMultiVector), intent(in) :: self - -real(C_DOUBLE), dimension(:), target :: norms -real(C_DOUBLE), pointer :: farg2_view - -type(SwigClassWrapper) :: farg1 -type(SwigArrayWrapper) :: farg2 - -farg1 = self%swigdata -farg2_view => norms(1) -farg2%data = c_loc(farg2_view) -farg2%size = size(norms) -call swigc_TpetraMultiVector_norm1(farg1, farg2) -end subroutine - -subroutine swigf_TpetraMultiVector_norm2(self, norms) -use, intrinsic :: ISO_C_BINDING -class(TpetraMultiVector), intent(in) :: self - -real(C_DOUBLE), dimension(:), target :: norms -real(C_DOUBLE), pointer :: farg2_view - -type(SwigClassWrapper) :: farg1 -type(SwigArrayWrapper) :: farg2 - -farg1 = self%swigdata -farg2_view => norms(1) -farg2%data = c_loc(farg2_view) -farg2%size = size(norms) -call swigc_TpetraMultiVector_norm2(farg1, farg2) -end subroutine - -subroutine swigf_TpetraMultiVector_normInf(self, norms) -use, intrinsic :: ISO_C_BINDING -class(TpetraMultiVector), intent(in) :: self - -real(C_DOUBLE), dimension(:), target :: norms -real(C_DOUBLE), pointer :: farg2_view - -type(SwigClassWrapper) :: farg1 -type(SwigArrayWrapper) :: farg2 - -farg1 = self%swigdata -farg2_view => norms(1) -farg2%data = c_loc(farg2_view) -farg2%size = size(norms) -call swigc_TpetraMultiVector_normInf(farg1, farg2) -end subroutine - -subroutine swigf_TpetraMultiVector_scale__SWIG_2(self, alpha) -use, intrinsic :: ISO_C_BINDING -class(TpetraMultiVector), intent(inout) :: self - -real(C_DOUBLE), dimension(:), target :: alpha -real(C_DOUBLE), pointer :: farg2_view - -type(SwigClassWrapper) :: farg1 -type(SwigArrayWrapper) :: farg2 - -farg1 = self%swigdata -farg2_view => alpha(1) -farg2%data = c_loc(farg2_view) -farg2%size = size(alpha) -call swigc_TpetraMultiVector_scale__SWIG_2(farg1, farg2) -end subroutine - -subroutine swigf_TpetraMultiVector_meanValue(self, means) -use, intrinsic :: ISO_C_BINDING -class(TpetraMultiVector), intent(in) :: self - -real(C_DOUBLE), dimension(:), target :: means -real(C_DOUBLE), pointer :: farg2_view - -type(SwigClassWrapper) :: farg1 -type(SwigArrayWrapper) :: farg2 - -farg1 = self%swigdata -farg2_view => means(1) -farg2%data = c_loc(farg2_view) -farg2%size = size(means) -call swigc_TpetraMultiVector_meanValue(farg1, farg2) -end subroutine - -subroutine swigf_TpetraMultiVector_get1dCopy(self, a, lda) -use, intrinsic :: ISO_C_BINDING -class(TpetraMultiVector), intent(in) :: self - -real(C_DOUBLE), dimension(:), target :: a -real(C_DOUBLE), pointer :: farg2_view -integer(C_SIZE_T), intent(in) :: lda - -type(SwigClassWrapper) :: farg1 -type(SwigArrayWrapper) :: farg2 -integer(C_SIZE_T) :: farg3 - -farg1 = self%swigdata -farg2_view => a(1) -farg2%data = c_loc(farg2_view) -farg2%size = size(a) -farg3 = lda -call swigc_TpetraMultiVector_get1dCopy(farg1, farg2, farg3) -end subroutine - -function swigf_TpetraMultiVector_get1dView(self) & -result(swig_result) -use, intrinsic :: ISO_C_BINDING -real(C_DOUBLE), dimension(:), pointer :: swig_result -class(TpetraMultiVector), intent(in) :: self - -type(SwigArrayWrapper) :: fresult -type(SwigClassWrapper) :: farg1 - -farg1 = self%swigdata -fresult = swigc_TpetraMultiVector_get1dView(farg1) -call c_f_pointer(fresult%data, swig_result, [fresult%size]) -end function - -function swigf_TpetraMultiVector_get1dViewNonConst(self) & -result(swig_result) -use, intrinsic :: ISO_C_BINDING -real(C_DOUBLE), dimension(:), pointer :: swig_result -class(TpetraMultiVector), intent(inout) :: self - -type(SwigArrayWrapper) :: fresult -type(SwigClassWrapper) :: farg1 - -farg1 = self%swigdata -fresult = swigc_TpetraMultiVector_get1dViewNonConst(farg1) -call c_f_pointer(fresult%data, swig_result, [fresult%size]) -end function - subroutine swigf_TpetraMultiVector_doImport__SWIG_0(self, source, importer, cm) use, intrinsic :: ISO_C_BINDING class(TpetraMultiVector), intent(inout) :: self @@ -6979,20 +7073,6 @@ subroutine swigf_TpetraMultiVector_doExport__SWIG_1(self, source, importer, cm) call swigc_TpetraMultiVector_doExport__SWIG_1(farg1, farg2, farg3, farg4) end subroutine -function swigf_TpetraMultiVector_getMap(self) & -result(swig_result) -use, intrinsic :: ISO_C_BINDING -type(TpetraMap) :: swig_result -class(TpetraMultiVector), intent(in) :: self - -type(SwigClassWrapper) :: fresult -type(SwigClassWrapper) :: farg1 - -farg1 = self%swigdata -fresult = swigc_TpetraMultiVector_getMap(farg1) -swig_result%swigdata = fresult -end function - subroutine swigf_assignment_TpetraMultiVector(self, other) use, intrinsic :: ISO_C_BINDING class(TpetraMultiVector), intent(inout) :: self @@ -9039,7 +9119,7 @@ subroutine swigf_TpetraCrsGraph_getLocalRowCopy(self, localrow, indices, numindi call swigc_TpetraCrsGraph_getLocalRowCopy(farg1, farg2, farg3, farg4) end subroutine -subroutine swigf_TpetraCrsGraph_getgblRowView(self, gblrow, lclcolinds) +subroutine swigf_TpetraCrsGraph_getGlobalRowView(self, gblrow, lclcolinds) use, intrinsic :: ISO_C_BINDING class(TpetraCrsGraph), intent(in) :: self @@ -9056,7 +9136,7 @@ subroutine swigf_TpetraCrsGraph_getgblRowView(self, gblrow, lclcolinds) farg3_view => lclcolinds(1) farg3%data = c_loc(farg3_view) farg3%size = size(lclcolinds) -call swigc_TpetraCrsGraph_getgblRowView(farg1, farg2, farg3) +call swigc_TpetraCrsGraph_getGlobalRowView(farg1, farg2, farg3) end subroutine subroutine swigf_TpetraCrsGraph_setAllIndices(self, rowpointers, columnindices, val) diff --git a/src/tpetra/src/swig/fortpetraFORTRAN_wrap.cxx b/src/tpetra/src/swig/fortpetraFORTRAN_wrap.cxx index 9ad90075..42dfbc7d 100644 --- a/src/tpetra/src/swig/fortpetraFORTRAN_wrap.cxx +++ b/src/tpetra/src/swig/fortpetraFORTRAN_wrap.cxx @@ -621,72 +621,6 @@ using Tpetra::Import; #include "Tpetra_MultiVector.hpp" -SWIGINTERN Tpetra::MultiVector< SC,LO,GO,NO > *new_Tpetra_MultiVector_Sl_SC_Sc_LO_Sc_GO_Sc_NO_Sg___SWIG_8(Teuchos::RCP< Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &map,std::pair< SC const *,std::size_t > A,size_t const LDA,size_t const NumVectors){ - Teuchos::ArrayView AView = Teuchos::arrayView(A.first, A.second); - return new Tpetra::MultiVector(map, AView, LDA, NumVectors); - } -SWIGINTERN std::pair< SC const *,std::size_t > Tpetra_MultiVector_Sl_SC_Sc_LO_Sc_GO_Sc_NO_Sg__getData(Tpetra::MultiVector< SC,LO,GO,NO > const *self,size_t j){ - Teuchos::ArrayRCP a = self->getData(j); - return std::make_pair(a.get(), a.size()); - } -SWIGINTERN std::pair< SC *,std::size_t > Tpetra_MultiVector_Sl_SC_Sc_LO_Sc_GO_Sc_NO_Sg__getDataNonConst(Tpetra::MultiVector< SC,LO,GO,NO > *self,size_t j){ - Teuchos::ArrayRCP a = self->getDataNonConst(j); - return std::make_pair(a.get(), a.size()); - } -SWIGINTERN Teuchos::RCP< Tpetra::MultiVector< SC,LO,GO,NO > > Tpetra_MultiVector_Sl_SC_Sc_LO_Sc_GO_Sc_NO_Sg__subCopy(Tpetra::MultiVector< SC,LO,GO,NO > const *self,std::pair< std::size_t const *,std::size_t > cols){ - Teuchos::Array colsArray(cols.second); - for (int i = 0; i < colsArray.size(); i++) - colsArray[i] = cols.first[i]-1; - return self->subCopy(colsArray); - } -SWIGINTERN Teuchos::RCP< Tpetra::MultiVector< SC,LO,GO,NO > const > Tpetra_MultiVector_Sl_SC_Sc_LO_Sc_GO_Sc_NO_Sg__subView(Tpetra::MultiVector< SC,LO,GO,NO > const *self,std::pair< std::size_t const *,std::size_t > cols){ - Teuchos::Array colsArray(cols.second); - for (int i = 0; i < colsArray.size(); i++) - colsArray[i] = cols.first[i]-1; - return self->subView(colsArray); - } -SWIGINTERN Teuchos::RCP< Tpetra::MultiVector< SC,LO,GO,NO > > Tpetra_MultiVector_Sl_SC_Sc_LO_Sc_GO_Sc_NO_Sg__subViewNonConst(Tpetra::MultiVector< SC,LO,GO,NO > *self,std::pair< std::size_t const *,std::size_t > cols){ - Teuchos::Array colsArray(cols.second); - for (int i = 0; i < colsArray.size(); i++) - colsArray[i] = cols.first[i]-1; - return self->subViewNonConst(colsArray); - } -SWIGINTERN void Tpetra_MultiVector_Sl_SC_Sc_LO_Sc_GO_Sc_NO_Sg__dot(Tpetra::MultiVector< SC,LO,GO,NO > const *self,Tpetra::MultiVector< SC,LO,GO,NO > const &A,std::pair< SC *,std::size_t > dots){ - Teuchos::ArrayView dotsView = Teuchos::arrayView(dots.first, dots.second); - return self->dot(A, dotsView); - } -SWIGINTERN void Tpetra_MultiVector_Sl_SC_Sc_LO_Sc_GO_Sc_NO_Sg__norm1(Tpetra::MultiVector< SC,LO,GO,NO > const *self,std::pair< SC *,std::size_t > norms){ - Teuchos::ArrayView normsView = Teuchos::arrayView(norms.first, norms.second); - return self->norm1(normsView); - } -SWIGINTERN void Tpetra_MultiVector_Sl_SC_Sc_LO_Sc_GO_Sc_NO_Sg__norm2(Tpetra::MultiVector< SC,LO,GO,NO > const *self,std::pair< SC *,std::size_t > norms){ - Teuchos::ArrayView normsView = Teuchos::arrayView(norms.first, norms.second); - return self->norm2(normsView); - } -SWIGINTERN void Tpetra_MultiVector_Sl_SC_Sc_LO_Sc_GO_Sc_NO_Sg__normInf(Tpetra::MultiVector< SC,LO,GO,NO > const *self,std::pair< SC *,std::size_t > norms){ - Teuchos::ArrayView normsView = Teuchos::arrayView(norms.first, norms.second); - return self->normInf(normsView); - } -SWIGINTERN void Tpetra_MultiVector_Sl_SC_Sc_LO_Sc_GO_Sc_NO_Sg__scale__SWIG_2(Tpetra::MultiVector< SC,LO,GO,NO > *self,std::pair< SC const *,std::size_t > alpha){ - Teuchos::ArrayView alphaView = Teuchos::arrayView(alpha.first, alpha.second); - self->scale(alphaView); - } -SWIGINTERN void Tpetra_MultiVector_Sl_SC_Sc_LO_Sc_GO_Sc_NO_Sg__meanValue(Tpetra::MultiVector< SC,LO,GO,NO > const *self,std::pair< SC *,std::size_t > means){ - Teuchos::ArrayView meansView = Teuchos::arrayView(means.first, means.second); - self->meanValue(meansView); - } -SWIGINTERN void Tpetra_MultiVector_Sl_SC_Sc_LO_Sc_GO_Sc_NO_Sg__get1dCopy(Tpetra::MultiVector< SC,LO,GO,NO > const *self,std::pair< SC *,std::size_t > A,size_t const LDA){ - Teuchos::ArrayView AView = Teuchos::arrayView(A.first, A.second); - self->get1dCopy(AView, LDA); - } -SWIGINTERN std::pair< SC const *,std::size_t > Tpetra_MultiVector_Sl_SC_Sc_LO_Sc_GO_Sc_NO_Sg__get1dView(Tpetra::MultiVector< SC,LO,GO,NO > const *self){ - auto a = self->get1dView(); - return std::make_pair(a.getRawPtr(), a.size()); - } -SWIGINTERN std::pair< SC *,std::size_t > Tpetra_MultiVector_Sl_SC_Sc_LO_Sc_GO_Sc_NO_Sg__get1dViewNonConst(Tpetra::MultiVector< SC,LO,GO,NO > *self){ - auto a = self->get1dViewNonConst(); - return std::make_pair(a.getRawPtr(), a.size()); - } SWIGINTERN void Tpetra_MultiVector_Sl_SC_Sc_LO_Sc_GO_Sc_NO_Sg__doImport__SWIG_0(Tpetra::MultiVector< SC,LO,GO,NO > *self,Tpetra::MultiVector< SC,LO,GO,NO > const &source,Tpetra::Import< LO,GO,NO > const &importer,Tpetra::CombineMode CM){ self->doImport(source, importer, CM); } @@ -699,9 +633,6 @@ SWIGINTERN void Tpetra_MultiVector_Sl_SC_Sc_LO_Sc_GO_Sc_NO_Sg__doExport__SWIG_0( SWIGINTERN void Tpetra_MultiVector_Sl_SC_Sc_LO_Sc_GO_Sc_NO_Sg__doExport__SWIG_1(Tpetra::MultiVector< SC,LO,GO,NO > *self,Tpetra::MultiVector< SC,LO,GO,NO > const &source,Tpetra::Import< LO,GO,NO > const &importer,Tpetra::CombineMode CM){ self->doExport(source, importer, CM); } -SWIGINTERN Teuchos::RCP< Tpetra::Map< LO,GO,NO > const > Tpetra_MultiVector_Sl_SC_Sc_LO_Sc_GO_Sc_NO_Sg__getMap(Tpetra::MultiVector< SC,LO,GO,NO > const *self){ - return self->getMap(); - } #include "Tpetra_Operator.hpp" @@ -840,7 +771,7 @@ SWIGINTERN void Tpetra_CrsGraph_Sl_LO_Sc_GO_Sc_NO_Sg__getLocalRowCopy(Tpetra::Cr for (int i = 0; i < indicesView.size(); i++) indicesView[i]++; } -SWIGINTERN void Tpetra_CrsGraph_Sl_LO_Sc_GO_Sc_NO_Sg__getgblRowView(Tpetra::CrsGraph< LO,GO,NO > const *self,GO const gblRow,std::pair< GO const *,std::size_t > lclColInds){ +SWIGINTERN void Tpetra_CrsGraph_Sl_LO_Sc_GO_Sc_NO_Sg__getGlobalRowView(Tpetra::CrsGraph< LO,GO,NO > const *self,GO const gblRow,std::pair< GO const *,std::size_t > lclColInds){ Teuchos::ArrayView lclColIndsView = Teuchos::arrayView(lclColInds.first, lclColInds.second); self->getGlobalRowView(gblRow, lclColIndsView); } @@ -3699,7 +3630,53 @@ SWIGEXPORT SwigClassWrapper _wrap_new_TpetraMultiVector__SWIG_4(SwigClassWrapper } -SWIGEXPORT SwigClassWrapper _wrap_new_TpetraMultiVector__SWIG_6(SwigClassWrapper const *farg1, SwigClassWrapper const *farg2, size_t const *farg3) { +SWIGEXPORT SwigClassWrapper _wrap_new_TpetraMultiVector__SWIG_5(SwigClassWrapper const *farg1, SwigArrayWrapper *farg2, size_t const *farg3, size_t const *farg4) { + SwigClassWrapper fresult ; + Teuchos::RCP< Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > *arg1 = 0 ; + Teuchos::ArrayView< double const > *arg2 = 0 ; + size_t arg3 ; + size_t arg4 ; + Teuchos::RCP< Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > tempnull1 ; + double const *tempbegin2 ; + Teuchos::ArrayView< double const > temparr2 ; + Tpetra::MultiVector< SC,LO,GO,NO > *result = 0 ; + + arg1 = farg1->cptr ? static_cast< Teuchos::RCP< Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg1->cptr) : &tempnull1; + tempbegin2 = static_cast(farg2->data); + temparr2 = Teuchos::ArrayView(tempbegin2, farg2->size); + arg2 = &temparr2; + arg3 = static_cast< size_t >(*farg3); + arg4 = static_cast< size_t >(*farg4); + { + // Make sure no unhandled exceptions exist before performing a new action + SWIG_check_unhandled_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::MultiVector(Teuchos::RCP< Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::ArrayView< double const > const &,size_t const,size_t const)");; + try + { + // Attempt the wrapped function call + result = (Tpetra::MultiVector< SC,LO,GO,NO > *)new Tpetra::MultiVector< SC,LO,GO,NO >((Teuchos::RCP< Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &)*arg1,(Teuchos::ArrayView< double const > const &)*arg2,arg3,arg4); + } + catch (const std::range_error& e) + { + // Store a C++ exception + SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::MultiVector(Teuchos::RCP< Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::ArrayView< double const > const &,size_t const,size_t const)", SWIG_IndexError, e.what(), return SwigClassWrapper_uninitialized()); + } + catch (const std::exception& e) + { + // Store a C++ exception + SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::MultiVector(Teuchos::RCP< Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::ArrayView< double const > const &,size_t const,size_t const)", SWIG_RuntimeError, e.what(), return SwigClassWrapper_uninitialized()); + } + catch (...) + { + SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::MultiVector(Teuchos::RCP< Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::ArrayView< double const > const &,size_t const,size_t const)", SWIG_UnknownError, "An unknown exception occurred", return SwigClassWrapper_uninitialized()); + } + } + fresult.cptr = result ? new Teuchos::RCP< Tpetra::MultiVector >(result SWIG_NO_NULL_DELETER_1) : NULL; + fresult.mem = SWIG_MOVE; + return fresult; +} + + +SWIGEXPORT SwigClassWrapper _wrap_new_TpetraMultiVector__SWIG_7(SwigClassWrapper const *farg1, SwigClassWrapper const *farg2, size_t const *farg3) { SwigClassWrapper fresult ; Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > *arg1 = 0 ; Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type *arg2 = 0 ; @@ -3744,7 +3721,7 @@ SWIGEXPORT SwigClassWrapper _wrap_new_TpetraMultiVector__SWIG_6(SwigClassWrapper } -SWIGEXPORT SwigClassWrapper _wrap_new_TpetraMultiVector__SWIG_7(SwigClassWrapper const *farg1, SwigClassWrapper const *farg2) { +SWIGEXPORT SwigClassWrapper _wrap_new_TpetraMultiVector__SWIG_8(SwigClassWrapper const *farg1, SwigClassWrapper const *farg2) { SwigClassWrapper fresult ; Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > *arg1 = 0 ; Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type *arg2 = 0 ; @@ -4288,1545 +4265,1681 @@ SWIGEXPORT void _wrap_TpetraMultiVector_reduce(SwigClassWrapper const *farg1) { } -SWIGEXPORT SwigClassWrapper _wrap_TpetraMultiVector_offsetView(SwigClassWrapper const *farg1, SwigClassWrapper const *farg2, size_t const *farg3) { +SWIGEXPORT SwigClassWrapper _wrap_TpetraMultiVector_subCopy(SwigClassWrapper const *farg1, SwigArrayWrapper *farg2) { SwigClassWrapper fresult ; Tpetra::MultiVector< SC,LO,GO,NO > *arg1 = (Tpetra::MultiVector< SC,LO,GO,NO > *) 0 ; - Teuchos::RCP< Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > *arg2 = 0 ; - size_t arg3 ; + Teuchos::ArrayView< std::size_t const > *arg2 = 0 ; Teuchos::RCP< Tpetra::MultiVector< SC,LO,GO,NO > const > *smartarg1 ; - Teuchos::RCP< Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > tempnull2 ; - Teuchos::RCP< Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const > result; + unsigned long const *tempbegin2 ; + Teuchos::ArrayView< unsigned long const > temparr2 ; + Teuchos::RCP< Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > > result; smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); arg1 = smartarg1 ? const_cast< Tpetra::MultiVector* >(smartarg1->get()) : NULL; - arg2 = farg2->cptr ? static_cast< Teuchos::RCP< Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg2->cptr) : &tempnull2; - arg3 = static_cast< size_t >(*farg3); + tempbegin2 = static_cast(farg2->data); + temparr2 = Teuchos::ArrayView(tempbegin2, farg2->size); + arg2 = &temparr2; { // Make sure no unhandled exceptions exist before performing a new action - SWIG_check_unhandled_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::offsetView(Teuchos::RCP< Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,size_t const) const");; + SWIG_check_unhandled_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::subCopy(Teuchos::ArrayView< std::size_t const > const &) const");; try { // Attempt the wrapped function call - result = ((Tpetra::MultiVector< SC,LO,GO,NO > const *)arg1)->offsetView((Teuchos::RCP< Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &)*arg2,arg3); + result = ((Tpetra::MultiVector< SC,LO,GO,NO > const *)arg1)->subCopy((Teuchos::ArrayView< std::size_t const > const &)*arg2); } catch (const std::range_error& e) { // Store a C++ exception - SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::offsetView(Teuchos::RCP< Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,size_t const) const", SWIG_IndexError, e.what(), return SwigClassWrapper_uninitialized()); + SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::subCopy(Teuchos::ArrayView< std::size_t const > const &) const", SWIG_IndexError, e.what(), return SwigClassWrapper_uninitialized()); } catch (const std::exception& e) { // Store a C++ exception - SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::offsetView(Teuchos::RCP< Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,size_t const) const", SWIG_RuntimeError, e.what(), return SwigClassWrapper_uninitialized()); + SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::subCopy(Teuchos::ArrayView< std::size_t const > const &) const", SWIG_RuntimeError, e.what(), return SwigClassWrapper_uninitialized()); } catch (...) { - SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::offsetView(Teuchos::RCP< Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,size_t const) const", SWIG_UnknownError, "An unknown exception occurred", return SwigClassWrapper_uninitialized()); + SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::subCopy(Teuchos::ArrayView< std::size_t const > const &) const", SWIG_UnknownError, "An unknown exception occurred", return SwigClassWrapper_uninitialized()); } } - fresult.cptr = (new Teuchos::RCP >(static_cast< const Teuchos::RCP >& >(result))); + fresult.cptr = (new Teuchos::RCP< Tpetra::MultiVector >(static_cast< const Teuchos::RCP< Tpetra::MultiVector >& >(result))); fresult.mem = SWIG_MOVE; return fresult; } -SWIGEXPORT SwigClassWrapper _wrap_TpetraMultiVector_offsetViewNonConst(SwigClassWrapper const *farg1, SwigClassWrapper const *farg2, size_t const *farg3) { +SWIGEXPORT SwigClassWrapper _wrap_TpetraMultiVector_subView(SwigClassWrapper const *farg1, SwigArrayWrapper *farg2) { SwigClassWrapper fresult ; Tpetra::MultiVector< SC,LO,GO,NO > *arg1 = (Tpetra::MultiVector< SC,LO,GO,NO > *) 0 ; - Teuchos::RCP< Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > *arg2 = 0 ; - size_t arg3 ; - Teuchos::RCP< Tpetra::MultiVector< SC,LO,GO,NO > > *smartarg1 ; - Teuchos::RCP< Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > tempnull2 ; - Teuchos::RCP< Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > > result; + Teuchos::ArrayView< std::size_t const > *arg2 = 0 ; + Teuchos::RCP< Tpetra::MultiVector< SC,LO,GO,NO > const > *smartarg1 ; + unsigned long const *tempbegin2 ; + Teuchos::ArrayView< unsigned long const > temparr2 ; + Teuchos::RCP< Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const > result; - smartarg1 = static_cast< Teuchos::RCP< Tpetra::MultiVector >* >(farg1->cptr); + smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); arg1 = smartarg1 ? const_cast< Tpetra::MultiVector* >(smartarg1->get()) : NULL; - arg2 = farg2->cptr ? static_cast< Teuchos::RCP< Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg2->cptr) : &tempnull2; - arg3 = static_cast< size_t >(*farg3); + tempbegin2 = static_cast(farg2->data); + temparr2 = Teuchos::ArrayView(tempbegin2, farg2->size); + arg2 = &temparr2; { // Make sure no unhandled exceptions exist before performing a new action - SWIG_check_unhandled_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::offsetViewNonConst(Teuchos::RCP< Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,size_t const)");; + SWIG_check_unhandled_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::subView(Teuchos::ArrayView< std::size_t const > const &) const");; try { // Attempt the wrapped function call - result = (arg1)->offsetViewNonConst((Teuchos::RCP< Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &)*arg2,arg3); + result = ((Tpetra::MultiVector< SC,LO,GO,NO > const *)arg1)->subView((Teuchos::ArrayView< std::size_t const > const &)*arg2); } catch (const std::range_error& e) { // Store a C++ exception - SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::offsetViewNonConst(Teuchos::RCP< Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,size_t const)", SWIG_IndexError, e.what(), return SwigClassWrapper_uninitialized()); + SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::subView(Teuchos::ArrayView< std::size_t const > const &) const", SWIG_IndexError, e.what(), return SwigClassWrapper_uninitialized()); } catch (const std::exception& e) { // Store a C++ exception - SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::offsetViewNonConst(Teuchos::RCP< Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,size_t const)", SWIG_RuntimeError, e.what(), return SwigClassWrapper_uninitialized()); + SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::subView(Teuchos::ArrayView< std::size_t const > const &) const", SWIG_RuntimeError, e.what(), return SwigClassWrapper_uninitialized()); } catch (...) { - SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::offsetViewNonConst(Teuchos::RCP< Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,size_t const)", SWIG_UnknownError, "An unknown exception occurred", return SwigClassWrapper_uninitialized()); + SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::subView(Teuchos::ArrayView< std::size_t const > const &) const", SWIG_UnknownError, "An unknown exception occurred", return SwigClassWrapper_uninitialized()); } } - fresult.cptr = (new Teuchos::RCP< Tpetra::MultiVector >(static_cast< const Teuchos::RCP< Tpetra::MultiVector >& >(result))); + fresult.cptr = (new Teuchos::RCP >(static_cast< const Teuchos::RCP >& >(result))); fresult.mem = SWIG_MOVE; return fresult; } -SWIGEXPORT void _wrap_TpetraMultiVector_sync_host(SwigClassWrapper const *farg1) { +SWIGEXPORT SwigClassWrapper _wrap_TpetraMultiVector_subViewNonConst(SwigClassWrapper const *farg1, SwigArrayWrapper *farg2) { + SwigClassWrapper fresult ; Tpetra::MultiVector< SC,LO,GO,NO > *arg1 = (Tpetra::MultiVector< SC,LO,GO,NO > *) 0 ; + Teuchos::ArrayView< std::size_t const > *arg2 = 0 ; Teuchos::RCP< Tpetra::MultiVector< SC,LO,GO,NO > > *smartarg1 ; + unsigned long const *tempbegin2 ; + Teuchos::ArrayView< unsigned long const > temparr2 ; + Teuchos::RCP< Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > > result; smartarg1 = static_cast< Teuchos::RCP< Tpetra::MultiVector >* >(farg1->cptr); arg1 = smartarg1 ? const_cast< Tpetra::MultiVector* >(smartarg1->get()) : NULL; + tempbegin2 = static_cast(farg2->data); + temparr2 = Teuchos::ArrayView(tempbegin2, farg2->size); + arg2 = &temparr2; { // Make sure no unhandled exceptions exist before performing a new action - SWIG_check_unhandled_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::sync_host()");; + SWIG_check_unhandled_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::subViewNonConst(Teuchos::ArrayView< std::size_t const > const &)");; try { // Attempt the wrapped function call - (arg1)->sync_host(); + result = (arg1)->subViewNonConst((Teuchos::ArrayView< std::size_t const > const &)*arg2); } catch (const std::range_error& e) { // Store a C++ exception - SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::sync_host()", SWIG_IndexError, e.what(), return ); + SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::subViewNonConst(Teuchos::ArrayView< std::size_t const > const &)", SWIG_IndexError, e.what(), return SwigClassWrapper_uninitialized()); } catch (const std::exception& e) { // Store a C++ exception - SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::sync_host()", SWIG_RuntimeError, e.what(), return ); + SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::subViewNonConst(Teuchos::ArrayView< std::size_t const > const &)", SWIG_RuntimeError, e.what(), return SwigClassWrapper_uninitialized()); } catch (...) { - SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::sync_host()", SWIG_UnknownError, "An unknown exception occurred", return ); + SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::subViewNonConst(Teuchos::ArrayView< std::size_t const > const &)", SWIG_UnknownError, "An unknown exception occurred", return SwigClassWrapper_uninitialized()); } } - + fresult.cptr = (new Teuchos::RCP< Tpetra::MultiVector >(static_cast< const Teuchos::RCP< Tpetra::MultiVector >& >(result))); + fresult.mem = SWIG_MOVE; + return fresult; } -SWIGEXPORT void _wrap_TpetraMultiVector_sync_device(SwigClassWrapper const *farg1) { +SWIGEXPORT SwigClassWrapper _wrap_TpetraMultiVector_offsetView(SwigClassWrapper const *farg1, SwigClassWrapper const *farg2, size_t const *farg3) { + SwigClassWrapper fresult ; Tpetra::MultiVector< SC,LO,GO,NO > *arg1 = (Tpetra::MultiVector< SC,LO,GO,NO > *) 0 ; - Teuchos::RCP< Tpetra::MultiVector< SC,LO,GO,NO > > *smartarg1 ; + Teuchos::RCP< Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > *arg2 = 0 ; + size_t arg3 ; + Teuchos::RCP< Tpetra::MultiVector< SC,LO,GO,NO > const > *smartarg1 ; + Teuchos::RCP< Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > tempnull2 ; + Teuchos::RCP< Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const > result; - smartarg1 = static_cast< Teuchos::RCP< Tpetra::MultiVector >* >(farg1->cptr); + smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); arg1 = smartarg1 ? const_cast< Tpetra::MultiVector* >(smartarg1->get()) : NULL; + arg2 = farg2->cptr ? static_cast< Teuchos::RCP< Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg2->cptr) : &tempnull2; + arg3 = static_cast< size_t >(*farg3); { // Make sure no unhandled exceptions exist before performing a new action - SWIG_check_unhandled_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::sync_device()");; + SWIG_check_unhandled_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::offsetView(Teuchos::RCP< Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,size_t const) const");; try { // Attempt the wrapped function call - (arg1)->sync_device(); + result = ((Tpetra::MultiVector< SC,LO,GO,NO > const *)arg1)->offsetView((Teuchos::RCP< Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &)*arg2,arg3); } catch (const std::range_error& e) { // Store a C++ exception - SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::sync_device()", SWIG_IndexError, e.what(), return ); + SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::offsetView(Teuchos::RCP< Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,size_t const) const", SWIG_IndexError, e.what(), return SwigClassWrapper_uninitialized()); } catch (const std::exception& e) { // Store a C++ exception - SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::sync_device()", SWIG_RuntimeError, e.what(), return ); + SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::offsetView(Teuchos::RCP< Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,size_t const) const", SWIG_RuntimeError, e.what(), return SwigClassWrapper_uninitialized()); } catch (...) { - SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::sync_device()", SWIG_UnknownError, "An unknown exception occurred", return ); + SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::offsetView(Teuchos::RCP< Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,size_t const) const", SWIG_UnknownError, "An unknown exception occurred", return SwigClassWrapper_uninitialized()); } } - + fresult.cptr = (new Teuchos::RCP >(static_cast< const Teuchos::RCP >& >(result))); + fresult.mem = SWIG_MOVE; + return fresult; } -SWIGEXPORT int _wrap_TpetraMultiVector_need_sync_host(SwigClassWrapper const *farg1) { - int fresult ; +SWIGEXPORT SwigClassWrapper _wrap_TpetraMultiVector_offsetViewNonConst(SwigClassWrapper const *farg1, SwigClassWrapper const *farg2, size_t const *farg3) { + SwigClassWrapper fresult ; Tpetra::MultiVector< SC,LO,GO,NO > *arg1 = (Tpetra::MultiVector< SC,LO,GO,NO > *) 0 ; - Teuchos::RCP< Tpetra::MultiVector< SC,LO,GO,NO > const > *smartarg1 ; - bool result; + Teuchos::RCP< Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > *arg2 = 0 ; + size_t arg3 ; + Teuchos::RCP< Tpetra::MultiVector< SC,LO,GO,NO > > *smartarg1 ; + Teuchos::RCP< Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > tempnull2 ; + Teuchos::RCP< Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > > result; - smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); + smartarg1 = static_cast< Teuchos::RCP< Tpetra::MultiVector >* >(farg1->cptr); arg1 = smartarg1 ? const_cast< Tpetra::MultiVector* >(smartarg1->get()) : NULL; + arg2 = farg2->cptr ? static_cast< Teuchos::RCP< Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg2->cptr) : &tempnull2; + arg3 = static_cast< size_t >(*farg3); { // Make sure no unhandled exceptions exist before performing a new action - SWIG_check_unhandled_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::need_sync_host() const");; + SWIG_check_unhandled_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::offsetViewNonConst(Teuchos::RCP< Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,size_t const)");; try { // Attempt the wrapped function call - result = (bool)((Tpetra::MultiVector< SC,LO,GO,NO > const *)arg1)->need_sync_host(); + result = (arg1)->offsetViewNonConst((Teuchos::RCP< Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &)*arg2,arg3); } catch (const std::range_error& e) { // Store a C++ exception - SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::need_sync_host() const", SWIG_IndexError, e.what(), return 0); + SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::offsetViewNonConst(Teuchos::RCP< Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,size_t const)", SWIG_IndexError, e.what(), return SwigClassWrapper_uninitialized()); } catch (const std::exception& e) { // Store a C++ exception - SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::need_sync_host() const", SWIG_RuntimeError, e.what(), return 0); + SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::offsetViewNonConst(Teuchos::RCP< Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,size_t const)", SWIG_RuntimeError, e.what(), return SwigClassWrapper_uninitialized()); } catch (...) { - SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::need_sync_host() const", SWIG_UnknownError, "An unknown exception occurred", return 0); + SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::offsetViewNonConst(Teuchos::RCP< Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,size_t const)", SWIG_UnknownError, "An unknown exception occurred", return SwigClassWrapper_uninitialized()); } } - fresult = (result ? 1 : 0); + fresult.cptr = (new Teuchos::RCP< Tpetra::MultiVector >(static_cast< const Teuchos::RCP< Tpetra::MultiVector >& >(result))); + fresult.mem = SWIG_MOVE; return fresult; } -SWIGEXPORT int _wrap_TpetraMultiVector_need_sync_device(SwigClassWrapper const *farg1) { - int fresult ; +SWIGEXPORT SwigArrayWrapper _wrap_TpetraMultiVector_getData(SwigClassWrapper const *farg1, size_t const *farg2) { + SwigArrayWrapper fresult ; Tpetra::MultiVector< SC,LO,GO,NO > *arg1 = (Tpetra::MultiVector< SC,LO,GO,NO > *) 0 ; + size_t arg2 ; Teuchos::RCP< Tpetra::MultiVector< SC,LO,GO,NO > const > *smartarg1 ; - bool result; + Teuchos::ArrayRCP< double const > result; smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); arg1 = smartarg1 ? const_cast< Tpetra::MultiVector* >(smartarg1->get()) : NULL; + arg2 = *farg2 - 1; { // Make sure no unhandled exceptions exist before performing a new action - SWIG_check_unhandled_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::need_sync_device() const");; + SWIG_check_unhandled_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::getData(size_t) const");; try { // Attempt the wrapped function call - result = (bool)((Tpetra::MultiVector< SC,LO,GO,NO > const *)arg1)->need_sync_device(); + result = ((Tpetra::MultiVector< SC,LO,GO,NO > const *)arg1)->getData(arg2); } catch (const std::range_error& e) { // Store a C++ exception - SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::need_sync_device() const", SWIG_IndexError, e.what(), return 0); + SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::getData(size_t) const", SWIG_IndexError, e.what(), return SwigArrayWrapper_uninitialized()); } catch (const std::exception& e) { // Store a C++ exception - SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::need_sync_device() const", SWIG_RuntimeError, e.what(), return 0); + SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::getData(size_t) const", SWIG_RuntimeError, e.what(), return SwigArrayWrapper_uninitialized()); } catch (...) { - SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::need_sync_device() const", SWIG_UnknownError, "An unknown exception occurred", return 0); + SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::getData(size_t) const", SWIG_UnknownError, "An unknown exception occurred", return SwigArrayWrapper_uninitialized()); } } - fresult = (result ? 1 : 0); + fresult.data = (void*)(&result)->getRawPtr(); + fresult.size = (&result)->size(); return fresult; } -SWIGEXPORT void _wrap_TpetraMultiVector_modify_device(SwigClassWrapper const *farg1) { +SWIGEXPORT SwigArrayWrapper _wrap_TpetraMultiVector_getDataNonConst(SwigClassWrapper const *farg1, size_t const *farg2) { + SwigArrayWrapper fresult ; Tpetra::MultiVector< SC,LO,GO,NO > *arg1 = (Tpetra::MultiVector< SC,LO,GO,NO > *) 0 ; + size_t arg2 ; Teuchos::RCP< Tpetra::MultiVector< SC,LO,GO,NO > > *smartarg1 ; + Teuchos::ArrayRCP< double > result; smartarg1 = static_cast< Teuchos::RCP< Tpetra::MultiVector >* >(farg1->cptr); arg1 = smartarg1 ? const_cast< Tpetra::MultiVector* >(smartarg1->get()) : NULL; + arg2 = *farg2 - 1; { // Make sure no unhandled exceptions exist before performing a new action - SWIG_check_unhandled_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::modify_device()");; + SWIG_check_unhandled_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::getDataNonConst(size_t)");; try { // Attempt the wrapped function call - (arg1)->modify_device(); + result = (arg1)->getDataNonConst(arg2); } catch (const std::range_error& e) { // Store a C++ exception - SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::modify_device()", SWIG_IndexError, e.what(), return ); + SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::getDataNonConst(size_t)", SWIG_IndexError, e.what(), return SwigArrayWrapper_uninitialized()); } catch (const std::exception& e) { // Store a C++ exception - SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::modify_device()", SWIG_RuntimeError, e.what(), return ); + SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::getDataNonConst(size_t)", SWIG_RuntimeError, e.what(), return SwigArrayWrapper_uninitialized()); } catch (...) { - SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::modify_device()", SWIG_UnknownError, "An unknown exception occurred", return ); + SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::getDataNonConst(size_t)", SWIG_UnknownError, "An unknown exception occurred", return SwigArrayWrapper_uninitialized()); } } - + fresult.data = (void*)(&result)->getRawPtr(); + fresult.size = (&result)->size(); + return fresult; } -SWIGEXPORT void _wrap_TpetraMultiVector_modify_host(SwigClassWrapper const *farg1) { +SWIGEXPORT void _wrap_TpetraMultiVector_get1dCopy(SwigClassWrapper const *farg1, SwigArrayWrapper *farg2, size_t const *farg3) { Tpetra::MultiVector< SC,LO,GO,NO > *arg1 = (Tpetra::MultiVector< SC,LO,GO,NO > *) 0 ; - Teuchos::RCP< Tpetra::MultiVector< SC,LO,GO,NO > > *smartarg1 ; + Teuchos::ArrayView< double > *arg2 = 0 ; + size_t arg3 ; + Teuchos::RCP< Tpetra::MultiVector< SC,LO,GO,NO > const > *smartarg1 ; + double *tempbegin2 ; + Teuchos::ArrayView< double > temparr2 ; - smartarg1 = static_cast< Teuchos::RCP< Tpetra::MultiVector >* >(farg1->cptr); + smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); arg1 = smartarg1 ? const_cast< Tpetra::MultiVector* >(smartarg1->get()) : NULL; + tempbegin2 = static_cast(farg2->data); + temparr2 = Teuchos::ArrayView(tempbegin2, farg2->size); + arg2 = &temparr2; + arg3 = static_cast< size_t >(*farg3); { // Make sure no unhandled exceptions exist before performing a new action - SWIG_check_unhandled_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::modify_host()");; + SWIG_check_unhandled_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::get1dCopy(Teuchos::ArrayView< double > const &,size_t const) const");; try { // Attempt the wrapped function call - (arg1)->modify_host(); + ((Tpetra::MultiVector< SC,LO,GO,NO > const *)arg1)->get1dCopy((Teuchos::ArrayView< double > const &)*arg2,arg3); } catch (const std::range_error& e) { // Store a C++ exception - SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::modify_host()", SWIG_IndexError, e.what(), return ); + SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::get1dCopy(Teuchos::ArrayView< double > const &,size_t const) const", SWIG_IndexError, e.what(), return ); } catch (const std::exception& e) { // Store a C++ exception - SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::modify_host()", SWIG_RuntimeError, e.what(), return ); + SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::get1dCopy(Teuchos::ArrayView< double > const &,size_t const) const", SWIG_RuntimeError, e.what(), return ); } catch (...) { - SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::modify_host()", SWIG_UnknownError, "An unknown exception occurred", return ); + SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::get1dCopy(Teuchos::ArrayView< double > const &,size_t const) const", SWIG_UnknownError, "An unknown exception occurred", return ); } } } -SWIGEXPORT void _wrap_TpetraMultiVector_abs(SwigClassWrapper const *farg1, SwigClassWrapper const *farg2) { +SWIGEXPORT SwigArrayWrapper _wrap_TpetraMultiVector_get1dView(SwigClassWrapper const *farg1) { + SwigArrayWrapper fresult ; Tpetra::MultiVector< SC,LO,GO,NO > *arg1 = (Tpetra::MultiVector< SC,LO,GO,NO > *) 0 ; - Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > *arg2 = 0 ; - Teuchos::RCP< Tpetra::MultiVector< SC,LO,GO,NO > > *smartarg1 ; - Teuchos::RCP< Tpetra::MultiVector< SC,LO,GO,NO > const > *smartarg2 ; + Teuchos::RCP< Tpetra::MultiVector< SC,LO,GO,NO > const > *smartarg1 ; + Teuchos::ArrayRCP< double const > result; - smartarg1 = static_cast< Teuchos::RCP< Tpetra::MultiVector >* >(farg1->cptr); + smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); arg1 = smartarg1 ? const_cast< Tpetra::MultiVector* >(smartarg1->get()) : NULL; - SWIG_check_sp_nonnull(farg2, "Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > *", "TpetraMultiVector", "Tpetra::MultiVector< SC,LO,GO,NO >::abs(Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &)", return ) - smartarg2 = static_cast< Teuchos::RCP >* >(farg2->cptr); - arg2 = const_cast< Tpetra::MultiVector* >(smartarg2->get()); { // Make sure no unhandled exceptions exist before performing a new action - SWIG_check_unhandled_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::abs(Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &)");; + SWIG_check_unhandled_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::get1dView() const");; try { // Attempt the wrapped function call - (arg1)->abs((Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &)*arg2); + result = ((Tpetra::MultiVector< SC,LO,GO,NO > const *)arg1)->get1dView(); } catch (const std::range_error& e) { // Store a C++ exception - SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::abs(Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &)", SWIG_IndexError, e.what(), return ); + SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::get1dView() const", SWIG_IndexError, e.what(), return SwigArrayWrapper_uninitialized()); } catch (const std::exception& e) { // Store a C++ exception - SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::abs(Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &)", SWIG_RuntimeError, e.what(), return ); + SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::get1dView() const", SWIG_RuntimeError, e.what(), return SwigArrayWrapper_uninitialized()); } catch (...) { - SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::abs(Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &)", SWIG_UnknownError, "An unknown exception occurred", return ); + SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::get1dView() const", SWIG_UnknownError, "An unknown exception occurred", return SwigArrayWrapper_uninitialized()); } } - + fresult.data = (void*)(&result)->getRawPtr(); + fresult.size = (&result)->size(); + return fresult; } -SWIGEXPORT void _wrap_TpetraMultiVector_reciprocal(SwigClassWrapper const *farg1, SwigClassWrapper const *farg2) { +SWIGEXPORT SwigArrayWrapper _wrap_TpetraMultiVector_get1dViewNonConst(SwigClassWrapper const *farg1) { + SwigArrayWrapper fresult ; Tpetra::MultiVector< SC,LO,GO,NO > *arg1 = (Tpetra::MultiVector< SC,LO,GO,NO > *) 0 ; - Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > *arg2 = 0 ; Teuchos::RCP< Tpetra::MultiVector< SC,LO,GO,NO > > *smartarg1 ; - Teuchos::RCP< Tpetra::MultiVector< SC,LO,GO,NO > const > *smartarg2 ; + Teuchos::ArrayRCP< double > result; smartarg1 = static_cast< Teuchos::RCP< Tpetra::MultiVector >* >(farg1->cptr); arg1 = smartarg1 ? const_cast< Tpetra::MultiVector* >(smartarg1->get()) : NULL; - SWIG_check_sp_nonnull(farg2, "Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > *", "TpetraMultiVector", "Tpetra::MultiVector< SC,LO,GO,NO >::reciprocal(Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &)", return ) - smartarg2 = static_cast< Teuchos::RCP >* >(farg2->cptr); - arg2 = const_cast< Tpetra::MultiVector* >(smartarg2->get()); { // Make sure no unhandled exceptions exist before performing a new action - SWIG_check_unhandled_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::reciprocal(Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &)");; + SWIG_check_unhandled_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::get1dViewNonConst()");; try { // Attempt the wrapped function call - (arg1)->reciprocal((Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &)*arg2); + result = (arg1)->get1dViewNonConst(); } catch (const std::range_error& e) { // Store a C++ exception - SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::reciprocal(Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &)", SWIG_IndexError, e.what(), return ); + SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::get1dViewNonConst()", SWIG_IndexError, e.what(), return SwigArrayWrapper_uninitialized()); } catch (const std::exception& e) { // Store a C++ exception - SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::reciprocal(Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &)", SWIG_RuntimeError, e.what(), return ); + SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::get1dViewNonConst()", SWIG_RuntimeError, e.what(), return SwigArrayWrapper_uninitialized()); } catch (...) { - SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::reciprocal(Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &)", SWIG_UnknownError, "An unknown exception occurred", return ); + SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::get1dViewNonConst()", SWIG_UnknownError, "An unknown exception occurred", return SwigArrayWrapper_uninitialized()); } } - + fresult.data = (void*)(&result)->getRawPtr(); + fresult.size = (&result)->size(); + return fresult; } -SWIGEXPORT void _wrap_TpetraMultiVector_scale__SWIG_0(SwigClassWrapper const *farg1, double const *farg2) { +SWIGEXPORT void _wrap_TpetraMultiVector_sync_host(SwigClassWrapper const *farg1) { Tpetra::MultiVector< SC,LO,GO,NO > *arg1 = (Tpetra::MultiVector< SC,LO,GO,NO > *) 0 ; - double *arg2 = 0 ; Teuchos::RCP< Tpetra::MultiVector< SC,LO,GO,NO > > *smartarg1 ; - double temp2 ; smartarg1 = static_cast< Teuchos::RCP< Tpetra::MultiVector >* >(farg1->cptr); arg1 = smartarg1 ? const_cast< Tpetra::MultiVector* >(smartarg1->get()) : NULL; - temp2 = static_cast< double >(*farg2); - arg2 = &temp2; { // Make sure no unhandled exceptions exist before performing a new action - SWIG_check_unhandled_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::scale(double const &)");; + SWIG_check_unhandled_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::sync_host()");; try { // Attempt the wrapped function call - (arg1)->scale((double const &)*arg2); + (arg1)->sync_host(); } catch (const std::range_error& e) { // Store a C++ exception - SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::scale(double const &)", SWIG_IndexError, e.what(), return ); + SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::sync_host()", SWIG_IndexError, e.what(), return ); } catch (const std::exception& e) { // Store a C++ exception - SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::scale(double const &)", SWIG_RuntimeError, e.what(), return ); + SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::sync_host()", SWIG_RuntimeError, e.what(), return ); } catch (...) { - SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::scale(double const &)", SWIG_UnknownError, "An unknown exception occurred", return ); + SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::sync_host()", SWIG_UnknownError, "An unknown exception occurred", return ); } } } -SWIGEXPORT void _wrap_TpetraMultiVector_scale__SWIG_1(SwigClassWrapper const *farg1, double const *farg2, SwigClassWrapper const *farg3) { +SWIGEXPORT void _wrap_TpetraMultiVector_sync_device(SwigClassWrapper const *farg1) { Tpetra::MultiVector< SC,LO,GO,NO > *arg1 = (Tpetra::MultiVector< SC,LO,GO,NO > *) 0 ; - double *arg2 = 0 ; - Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > *arg3 = 0 ; Teuchos::RCP< Tpetra::MultiVector< SC,LO,GO,NO > > *smartarg1 ; - double temp2 ; - Teuchos::RCP< Tpetra::MultiVector< SC,LO,GO,NO > const > *smartarg3 ; smartarg1 = static_cast< Teuchos::RCP< Tpetra::MultiVector >* >(farg1->cptr); arg1 = smartarg1 ? const_cast< Tpetra::MultiVector* >(smartarg1->get()) : NULL; - temp2 = static_cast< double >(*farg2); - arg2 = &temp2; - SWIG_check_sp_nonnull(farg3, "Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > *", "TpetraMultiVector", "Tpetra::MultiVector< SC,LO,GO,NO >::scale(double const &,Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &)", return ) - smartarg3 = static_cast< Teuchos::RCP >* >(farg3->cptr); - arg3 = const_cast< Tpetra::MultiVector* >(smartarg3->get()); { // Make sure no unhandled exceptions exist before performing a new action - SWIG_check_unhandled_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::scale(double const &,Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &)");; + SWIG_check_unhandled_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::sync_device()");; try { // Attempt the wrapped function call - (arg1)->scale((double const &)*arg2,(Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &)*arg3); + (arg1)->sync_device(); } catch (const std::range_error& e) { // Store a C++ exception - SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::scale(double const &,Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &)", SWIG_IndexError, e.what(), return ); + SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::sync_device()", SWIG_IndexError, e.what(), return ); } catch (const std::exception& e) { // Store a C++ exception - SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::scale(double const &,Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &)", SWIG_RuntimeError, e.what(), return ); + SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::sync_device()", SWIG_RuntimeError, e.what(), return ); } catch (...) { - SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::scale(double const &,Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &)", SWIG_UnknownError, "An unknown exception occurred", return ); + SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::sync_device()", SWIG_UnknownError, "An unknown exception occurred", return ); } } } -SWIGEXPORT void _wrap_TpetraMultiVector_update__SWIG_0(SwigClassWrapper const *farg1, double const *farg2, SwigClassWrapper const *farg3, double const *farg4) { +SWIGEXPORT int _wrap_TpetraMultiVector_need_sync_host(SwigClassWrapper const *farg1) { + int fresult ; Tpetra::MultiVector< SC,LO,GO,NO > *arg1 = (Tpetra::MultiVector< SC,LO,GO,NO > *) 0 ; - double *arg2 = 0 ; - Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > *arg3 = 0 ; - double *arg4 = 0 ; - Teuchos::RCP< Tpetra::MultiVector< SC,LO,GO,NO > > *smartarg1 ; - double temp2 ; - Teuchos::RCP< Tpetra::MultiVector< SC,LO,GO,NO > const > *smartarg3 ; - double temp4 ; + Teuchos::RCP< Tpetra::MultiVector< SC,LO,GO,NO > const > *smartarg1 ; + bool result; - smartarg1 = static_cast< Teuchos::RCP< Tpetra::MultiVector >* >(farg1->cptr); + smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); arg1 = smartarg1 ? const_cast< Tpetra::MultiVector* >(smartarg1->get()) : NULL; - temp2 = static_cast< double >(*farg2); - arg2 = &temp2; - SWIG_check_sp_nonnull(farg3, "Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > *", "TpetraMultiVector", "Tpetra::MultiVector< SC,LO,GO,NO >::update(double const &,Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &,double const &)", return ) - smartarg3 = static_cast< Teuchos::RCP >* >(farg3->cptr); - arg3 = const_cast< Tpetra::MultiVector* >(smartarg3->get()); - temp4 = static_cast< double >(*farg4); - arg4 = &temp4; { // Make sure no unhandled exceptions exist before performing a new action - SWIG_check_unhandled_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::update(double const &,Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &,double const &)");; + SWIG_check_unhandled_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::need_sync_host() const");; try { // Attempt the wrapped function call - (arg1)->update((double const &)*arg2,(Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &)*arg3,(double const &)*arg4); + result = (bool)((Tpetra::MultiVector< SC,LO,GO,NO > const *)arg1)->need_sync_host(); } catch (const std::range_error& e) { // Store a C++ exception - SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::update(double const &,Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &,double const &)", SWIG_IndexError, e.what(), return ); + SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::need_sync_host() const", SWIG_IndexError, e.what(), return 0); } catch (const std::exception& e) { // Store a C++ exception - SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::update(double const &,Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &,double const &)", SWIG_RuntimeError, e.what(), return ); + SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::need_sync_host() const", SWIG_RuntimeError, e.what(), return 0); } catch (...) { - SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::update(double const &,Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &,double const &)", SWIG_UnknownError, "An unknown exception occurred", return ); + SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::need_sync_host() const", SWIG_UnknownError, "An unknown exception occurred", return 0); } } + fresult = (result ? 1 : 0); + return fresult; +} + + +SWIGEXPORT int _wrap_TpetraMultiVector_need_sync_device(SwigClassWrapper const *farg1) { + int fresult ; + Tpetra::MultiVector< SC,LO,GO,NO > *arg1 = (Tpetra::MultiVector< SC,LO,GO,NO > *) 0 ; + Teuchos::RCP< Tpetra::MultiVector< SC,LO,GO,NO > const > *smartarg1 ; + bool result; + smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::MultiVector* >(smartarg1->get()) : NULL; + { + // Make sure no unhandled exceptions exist before performing a new action + SWIG_check_unhandled_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::need_sync_device() const");; + try + { + // Attempt the wrapped function call + result = (bool)((Tpetra::MultiVector< SC,LO,GO,NO > const *)arg1)->need_sync_device(); + } + catch (const std::range_error& e) + { + // Store a C++ exception + SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::need_sync_device() const", SWIG_IndexError, e.what(), return 0); + } + catch (const std::exception& e) + { + // Store a C++ exception + SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::need_sync_device() const", SWIG_RuntimeError, e.what(), return 0); + } + catch (...) + { + SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::need_sync_device() const", SWIG_UnknownError, "An unknown exception occurred", return 0); + } + } + fresult = (result ? 1 : 0); + return fresult; } -SWIGEXPORT void _wrap_TpetraMultiVector_update__SWIG_1(SwigClassWrapper const *farg1, double const *farg2, SwigClassWrapper const *farg3, double const *farg4, SwigClassWrapper const *farg5, double const *farg6) { +SWIGEXPORT void _wrap_TpetraMultiVector_modify_device(SwigClassWrapper const *farg1) { Tpetra::MultiVector< SC,LO,GO,NO > *arg1 = (Tpetra::MultiVector< SC,LO,GO,NO > *) 0 ; - double *arg2 = 0 ; - Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > *arg3 = 0 ; - double *arg4 = 0 ; - Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > *arg5 = 0 ; - double *arg6 = 0 ; Teuchos::RCP< Tpetra::MultiVector< SC,LO,GO,NO > > *smartarg1 ; - double temp2 ; - Teuchos::RCP< Tpetra::MultiVector< SC,LO,GO,NO > const > *smartarg3 ; - double temp4 ; - Teuchos::RCP< Tpetra::MultiVector< SC,LO,GO,NO > const > *smartarg5 ; - double temp6 ; smartarg1 = static_cast< Teuchos::RCP< Tpetra::MultiVector >* >(farg1->cptr); arg1 = smartarg1 ? const_cast< Tpetra::MultiVector* >(smartarg1->get()) : NULL; - temp2 = static_cast< double >(*farg2); - arg2 = &temp2; - SWIG_check_sp_nonnull(farg3, "Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > *", "TpetraMultiVector", "Tpetra::MultiVector< SC,LO,GO,NO >::update(double const &,Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &,double const &,Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &,double const &)", return ) - smartarg3 = static_cast< Teuchos::RCP >* >(farg3->cptr); - arg3 = const_cast< Tpetra::MultiVector* >(smartarg3->get()); - temp4 = static_cast< double >(*farg4); - arg4 = &temp4; - SWIG_check_sp_nonnull(farg5, "Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > *", "TpetraMultiVector", "Tpetra::MultiVector< SC,LO,GO,NO >::update(double const &,Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &,double const &,Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &,double const &)", return ) - smartarg5 = static_cast< Teuchos::RCP >* >(farg5->cptr); - arg5 = const_cast< Tpetra::MultiVector* >(smartarg5->get()); - temp6 = static_cast< double >(*farg6); - arg6 = &temp6; { // Make sure no unhandled exceptions exist before performing a new action - SWIG_check_unhandled_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::update(double const &,Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &,double const &,Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &,double const &)");; + SWIG_check_unhandled_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::modify_device()");; try { // Attempt the wrapped function call - (arg1)->update((double const &)*arg2,(Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &)*arg3,(double const &)*arg4,(Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &)*arg5,(double const &)*arg6); + (arg1)->modify_device(); } catch (const std::range_error& e) { // Store a C++ exception - SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::update(double const &,Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &,double const &,Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &,double const &)", SWIG_IndexError, e.what(), return ); + SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::modify_device()", SWIG_IndexError, e.what(), return ); } catch (const std::exception& e) { // Store a C++ exception - SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::update(double const &,Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &,double const &,Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &,double const &)", SWIG_RuntimeError, e.what(), return ); + SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::modify_device()", SWIG_RuntimeError, e.what(), return ); } catch (...) { - SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::update(double const &,Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &,double const &,Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &,double const &)", SWIG_UnknownError, "An unknown exception occurred", return ); + SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::modify_device()", SWIG_UnknownError, "An unknown exception occurred", return ); } } } -SWIGEXPORT void _wrap_TpetraMultiVector_multiply(SwigClassWrapper const *farg1, int const *farg2, int const *farg3, double const *farg4, SwigClassWrapper const *farg5, SwigClassWrapper const *farg6, double const *farg7) { +SWIGEXPORT void _wrap_TpetraMultiVector_modify_host(SwigClassWrapper const *farg1) { Tpetra::MultiVector< SC,LO,GO,NO > *arg1 = (Tpetra::MultiVector< SC,LO,GO,NO > *) 0 ; - Teuchos::ETransp arg2 ; - Teuchos::ETransp arg3 ; - double *arg4 = 0 ; - Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > *arg5 = 0 ; - Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > *arg6 = 0 ; - double *arg7 = 0 ; Teuchos::RCP< Tpetra::MultiVector< SC,LO,GO,NO > > *smartarg1 ; - double temp4 ; - Teuchos::RCP< Tpetra::MultiVector< SC,LO,GO,NO > const > *smartarg5 ; - Teuchos::RCP< Tpetra::MultiVector< SC,LO,GO,NO > const > *smartarg6 ; - double temp7 ; smartarg1 = static_cast< Teuchos::RCP< Tpetra::MultiVector >* >(farg1->cptr); arg1 = smartarg1 ? const_cast< Tpetra::MultiVector* >(smartarg1->get()) : NULL; - arg2 = static_cast< Teuchos::ETransp >(*farg2); - arg3 = static_cast< Teuchos::ETransp >(*farg3); - temp4 = static_cast< double >(*farg4); - arg4 = &temp4; - SWIG_check_sp_nonnull(farg5, "Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > *", "TpetraMultiVector", "Tpetra::MultiVector< SC,LO,GO,NO >::multiply(Teuchos::ETransp,Teuchos::ETransp,double const &,Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &,Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &,double const &)", return ) - smartarg5 = static_cast< Teuchos::RCP >* >(farg5->cptr); - arg5 = const_cast< Tpetra::MultiVector* >(smartarg5->get()); - SWIG_check_sp_nonnull(farg6, "Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > *", "TpetraMultiVector", "Tpetra::MultiVector< SC,LO,GO,NO >::multiply(Teuchos::ETransp,Teuchos::ETransp,double const &,Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &,Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &,double const &)", return ) - smartarg6 = static_cast< Teuchos::RCP >* >(farg6->cptr); - arg6 = const_cast< Tpetra::MultiVector* >(smartarg6->get()); - temp7 = static_cast< double >(*farg7); - arg7 = &temp7; { // Make sure no unhandled exceptions exist before performing a new action - SWIG_check_unhandled_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::multiply(Teuchos::ETransp,Teuchos::ETransp,double const &,Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &,Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &,double const &)");; + SWIG_check_unhandled_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::modify_host()");; try { // Attempt the wrapped function call - (arg1)->multiply(arg2,arg3,(double const &)*arg4,(Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &)*arg5,(Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &)*arg6,(double const &)*arg7); + (arg1)->modify_host(); } catch (const std::range_error& e) { // Store a C++ exception - SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::multiply(Teuchos::ETransp,Teuchos::ETransp,double const &,Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &,Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &,double const &)", SWIG_IndexError, e.what(), return ); + SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::modify_host()", SWIG_IndexError, e.what(), return ); } catch (const std::exception& e) { // Store a C++ exception - SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::multiply(Teuchos::ETransp,Teuchos::ETransp,double const &,Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &,Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &,double const &)", SWIG_RuntimeError, e.what(), return ); + SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::modify_host()", SWIG_RuntimeError, e.what(), return ); } catch (...) { - SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::multiply(Teuchos::ETransp,Teuchos::ETransp,double const &,Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &,Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &,double const &)", SWIG_UnknownError, "An unknown exception occurred", return ); + SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::modify_host()", SWIG_UnknownError, "An unknown exception occurred", return ); } } } -SWIGEXPORT size_t _wrap_TpetraMultiVector_getNumVectors(SwigClassWrapper const *farg1) { - size_t fresult ; +SWIGEXPORT void _wrap_TpetraMultiVector_dot__SWIG_0(SwigClassWrapper const *farg1, SwigClassWrapper const *farg2, SwigArrayWrapper *farg3) { Tpetra::MultiVector< SC,LO,GO,NO > *arg1 = (Tpetra::MultiVector< SC,LO,GO,NO > *) 0 ; + Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > *arg2 = 0 ; + Teuchos::ArrayView< Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::dot_type > *arg3 = 0 ; Teuchos::RCP< Tpetra::MultiVector< SC,LO,GO,NO > const > *smartarg1 ; - size_t result; + Teuchos::RCP< Tpetra::MultiVector< SC,LO,GO,NO > const > *smartarg2 ; + double *tempbegin3 ; + Teuchos::ArrayView< double > temparr3 ; smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); arg1 = smartarg1 ? const_cast< Tpetra::MultiVector* >(smartarg1->get()) : NULL; + SWIG_check_sp_nonnull(farg2, "Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > *", "TpetraMultiVector", "Tpetra::MultiVector< SC,LO,GO,NO >::dot(Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &,Teuchos::ArrayView< Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::dot_type > const &) const", return ) + smartarg2 = static_cast< Teuchos::RCP >* >(farg2->cptr); + arg2 = const_cast< Tpetra::MultiVector* >(smartarg2->get()); + tempbegin3 = static_cast(farg3->data); + temparr3 = Teuchos::ArrayView(tempbegin3, farg3->size); + arg3 = &temparr3; { // Make sure no unhandled exceptions exist before performing a new action - SWIG_check_unhandled_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::getNumVectors() const");; + SWIG_check_unhandled_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::dot(Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &,Teuchos::ArrayView< Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::dot_type > const &) const");; try { // Attempt the wrapped function call - result = (size_t)((Tpetra::MultiVector< SC,LO,GO,NO > const *)arg1)->getNumVectors(); + ((Tpetra::MultiVector< SC,LO,GO,NO > const *)arg1)->dot((Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &)*arg2,(Teuchos::ArrayView< Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::dot_type > const &)*arg3); } catch (const std::range_error& e) { // Store a C++ exception - SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::getNumVectors() const", SWIG_IndexError, e.what(), return 0); + SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::dot(Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &,Teuchos::ArrayView< Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::dot_type > const &) const", SWIG_IndexError, e.what(), return ); } catch (const std::exception& e) { // Store a C++ exception - SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::getNumVectors() const", SWIG_RuntimeError, e.what(), return 0); + SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::dot(Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &,Teuchos::ArrayView< Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::dot_type > const &) const", SWIG_RuntimeError, e.what(), return ); } catch (...) { - SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::getNumVectors() const", SWIG_UnknownError, "An unknown exception occurred", return 0); + SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::dot(Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &,Teuchos::ArrayView< Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::dot_type > const &) const", SWIG_UnknownError, "An unknown exception occurred", return ); } } - fresult = static_cast< size_t >(result); - return fresult; + } -SWIGEXPORT size_t _wrap_TpetraMultiVector_getLocalLength(SwigClassWrapper const *farg1) { - size_t fresult ; +SWIGEXPORT void _wrap_TpetraMultiVector_dot__SWIG_3(SwigClassWrapper const *farg1, SwigClassWrapper const *farg2, SwigClassWrapper const *farg3) { Tpetra::MultiVector< SC,LO,GO,NO > *arg1 = (Tpetra::MultiVector< SC,LO,GO,NO > *) 0 ; + Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > *arg2 = 0 ; + Kokkos::View< Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::dot_type *,Kokkos::HostSpace > *arg3 = 0 ; Teuchos::RCP< Tpetra::MultiVector< SC,LO,GO,NO > const > *smartarg1 ; - size_t result; + Teuchos::RCP< Tpetra::MultiVector< SC,LO,GO,NO > const > *smartarg2 ; smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); arg1 = smartarg1 ? const_cast< Tpetra::MultiVector* >(smartarg1->get()) : NULL; + SWIG_check_sp_nonnull(farg2, "Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > *", "TpetraMultiVector", "Tpetra::MultiVector< SC,LO,GO,NO >::dot(Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &,Kokkos::View< Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::dot_type *,Kokkos::HostSpace > const &) const", return ) + smartarg2 = static_cast< Teuchos::RCP >* >(farg2->cptr); + arg2 = const_cast< Tpetra::MultiVector* >(smartarg2->get()); + SWIG_check_nonnull(*farg3, "Kokkos::View< Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::dot_type *,Kokkos::HostSpace > const &", "SWIGTYPE_Kokkos__ViewT_double_p_Kokkos__HostSpace_t", "Tpetra::MultiVector< SC,LO,GO,NO >::dot(Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &,Kokkos::View< Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::dot_type *,Kokkos::HostSpace > const &) const", return ); + arg3 = static_cast< Kokkos::View< Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::dot_type *,Kokkos::HostSpace > * >(farg3->cptr); { // Make sure no unhandled exceptions exist before performing a new action - SWIG_check_unhandled_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::getLocalLength() const");; + SWIG_check_unhandled_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::dot(Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &,Kokkos::View< Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::dot_type *,Kokkos::HostSpace > const &) const");; try { // Attempt the wrapped function call - result = (size_t)((Tpetra::MultiVector< SC,LO,GO,NO > const *)arg1)->getLocalLength(); + ((Tpetra::MultiVector< SC,LO,GO,NO > const *)arg1)->dot((Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &)*arg2,(Kokkos::View< Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::dot_type *,Kokkos::HostSpace > const &)*arg3); } catch (const std::range_error& e) { // Store a C++ exception - SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::getLocalLength() const", SWIG_IndexError, e.what(), return 0); + SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::dot(Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &,Kokkos::View< Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::dot_type *,Kokkos::HostSpace > const &) const", SWIG_IndexError, e.what(), return ); } catch (const std::exception& e) { // Store a C++ exception - SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::getLocalLength() const", SWIG_RuntimeError, e.what(), return 0); + SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::dot(Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &,Kokkos::View< Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::dot_type *,Kokkos::HostSpace > const &) const", SWIG_RuntimeError, e.what(), return ); } catch (...) { - SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::getLocalLength() const", SWIG_UnknownError, "An unknown exception occurred", return 0); + SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::dot(Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &,Kokkos::View< Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::dot_type *,Kokkos::HostSpace > const &) const", SWIG_UnknownError, "An unknown exception occurred", return ); } } - fresult = static_cast< size_t >(result); - return fresult; + } -SWIGEXPORT long _wrap_TpetraMultiVector_getGlobalLength(SwigClassWrapper const *farg1) { - long fresult ; +SWIGEXPORT void _wrap_TpetraMultiVector_abs(SwigClassWrapper const *farg1, SwigClassWrapper const *farg2) { Tpetra::MultiVector< SC,LO,GO,NO > *arg1 = (Tpetra::MultiVector< SC,LO,GO,NO > *) 0 ; - Teuchos::RCP< Tpetra::MultiVector< SC,LO,GO,NO > const > *smartarg1 ; - Tpetra::global_size_t result; + Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > *arg2 = 0 ; + Teuchos::RCP< Tpetra::MultiVector< SC,LO,GO,NO > > *smartarg1 ; + Teuchos::RCP< Tpetra::MultiVector< SC,LO,GO,NO > const > *smartarg2 ; - smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); + smartarg1 = static_cast< Teuchos::RCP< Tpetra::MultiVector >* >(farg1->cptr); arg1 = smartarg1 ? const_cast< Tpetra::MultiVector* >(smartarg1->get()) : NULL; + SWIG_check_sp_nonnull(farg2, "Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > *", "TpetraMultiVector", "Tpetra::MultiVector< SC,LO,GO,NO >::abs(Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &)", return ) + smartarg2 = static_cast< Teuchos::RCP >* >(farg2->cptr); + arg2 = const_cast< Tpetra::MultiVector* >(smartarg2->get()); { // Make sure no unhandled exceptions exist before performing a new action - SWIG_check_unhandled_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::getGlobalLength() const");; + SWIG_check_unhandled_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::abs(Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &)");; try { // Attempt the wrapped function call - result = (Tpetra::global_size_t)((Tpetra::MultiVector< SC,LO,GO,NO > const *)arg1)->getGlobalLength(); + (arg1)->abs((Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &)*arg2); } catch (const std::range_error& e) { // Store a C++ exception - SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::getGlobalLength() const", SWIG_IndexError, e.what(), return 0); + SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::abs(Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &)", SWIG_IndexError, e.what(), return ); } catch (const std::exception& e) { // Store a C++ exception - SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::getGlobalLength() const", SWIG_RuntimeError, e.what(), return 0); + SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::abs(Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &)", SWIG_RuntimeError, e.what(), return ); } catch (...) { - SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::getGlobalLength() const", SWIG_UnknownError, "An unknown exception occurred", return 0); + SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::abs(Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &)", SWIG_UnknownError, "An unknown exception occurred", return ); } } - fresult = static_cast< Tpetra::global_size_t >(result); - return fresult; + } -SWIGEXPORT size_t _wrap_TpetraMultiVector_getStride(SwigClassWrapper const *farg1) { - size_t fresult ; +SWIGEXPORT void _wrap_TpetraMultiVector_reciprocal(SwigClassWrapper const *farg1, SwigClassWrapper const *farg2) { Tpetra::MultiVector< SC,LO,GO,NO > *arg1 = (Tpetra::MultiVector< SC,LO,GO,NO > *) 0 ; - Teuchos::RCP< Tpetra::MultiVector< SC,LO,GO,NO > const > *smartarg1 ; - size_t result; + Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > *arg2 = 0 ; + Teuchos::RCP< Tpetra::MultiVector< SC,LO,GO,NO > > *smartarg1 ; + Teuchos::RCP< Tpetra::MultiVector< SC,LO,GO,NO > const > *smartarg2 ; - smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); + smartarg1 = static_cast< Teuchos::RCP< Tpetra::MultiVector >* >(farg1->cptr); arg1 = smartarg1 ? const_cast< Tpetra::MultiVector* >(smartarg1->get()) : NULL; + SWIG_check_sp_nonnull(farg2, "Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > *", "TpetraMultiVector", "Tpetra::MultiVector< SC,LO,GO,NO >::reciprocal(Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &)", return ) + smartarg2 = static_cast< Teuchos::RCP >* >(farg2->cptr); + arg2 = const_cast< Tpetra::MultiVector* >(smartarg2->get()); { // Make sure no unhandled exceptions exist before performing a new action - SWIG_check_unhandled_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::getStride() const");; + SWIG_check_unhandled_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::reciprocal(Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &)");; try { // Attempt the wrapped function call - result = (size_t)((Tpetra::MultiVector< SC,LO,GO,NO > const *)arg1)->getStride(); + (arg1)->reciprocal((Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &)*arg2); } catch (const std::range_error& e) { // Store a C++ exception - SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::getStride() const", SWIG_IndexError, e.what(), return 0); + SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::reciprocal(Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &)", SWIG_IndexError, e.what(), return ); } catch (const std::exception& e) { // Store a C++ exception - SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::getStride() const", SWIG_RuntimeError, e.what(), return 0); + SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::reciprocal(Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &)", SWIG_RuntimeError, e.what(), return ); } catch (...) { - SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::getStride() const", SWIG_UnknownError, "An unknown exception occurred", return 0); + SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::reciprocal(Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &)", SWIG_UnknownError, "An unknown exception occurred", return ); } } - fresult = static_cast< size_t >(result); - return fresult; + } -SWIGEXPORT int _wrap_TpetraMultiVector_isConstantStride(SwigClassWrapper const *farg1) { - int fresult ; +SWIGEXPORT void _wrap_TpetraMultiVector_scale__SWIG_0(SwigClassWrapper const *farg1, double const *farg2) { Tpetra::MultiVector< SC,LO,GO,NO > *arg1 = (Tpetra::MultiVector< SC,LO,GO,NO > *) 0 ; - Teuchos::RCP< Tpetra::MultiVector< SC,LO,GO,NO > const > *smartarg1 ; - bool result; + double *arg2 = 0 ; + Teuchos::RCP< Tpetra::MultiVector< SC,LO,GO,NO > > *smartarg1 ; + double temp2 ; - smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); + smartarg1 = static_cast< Teuchos::RCP< Tpetra::MultiVector >* >(farg1->cptr); arg1 = smartarg1 ? const_cast< Tpetra::MultiVector* >(smartarg1->get()) : NULL; + temp2 = static_cast< double >(*farg2); + arg2 = &temp2; { // Make sure no unhandled exceptions exist before performing a new action - SWIG_check_unhandled_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::isConstantStride() const");; + SWIG_check_unhandled_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::scale(double const &)");; try { // Attempt the wrapped function call - result = (bool)((Tpetra::MultiVector< SC,LO,GO,NO > const *)arg1)->isConstantStride(); + (arg1)->scale((double const &)*arg2); } catch (const std::range_error& e) { // Store a C++ exception - SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::isConstantStride() const", SWIG_IndexError, e.what(), return 0); + SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::scale(double const &)", SWIG_IndexError, e.what(), return ); } catch (const std::exception& e) { // Store a C++ exception - SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::isConstantStride() const", SWIG_RuntimeError, e.what(), return 0); + SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::scale(double const &)", SWIG_RuntimeError, e.what(), return ); } catch (...) { - SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::isConstantStride() const", SWIG_UnknownError, "An unknown exception occurred", return 0); + SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::scale(double const &)", SWIG_UnknownError, "An unknown exception occurred", return ); } } - fresult = (result ? 1 : 0); - return fresult; + } -SWIGEXPORT SwigArrayWrapper _wrap_TpetraMultiVector_description(SwigClassWrapper const *farg1) { - SwigArrayWrapper fresult ; +SWIGEXPORT void _wrap_TpetraMultiVector_scale__SWIG_1(SwigClassWrapper const *farg1, SwigArrayWrapper *farg2) { Tpetra::MultiVector< SC,LO,GO,NO > *arg1 = (Tpetra::MultiVector< SC,LO,GO,NO > *) 0 ; - Teuchos::RCP< Tpetra::MultiVector< SC,LO,GO,NO > const > *smartarg1 ; - std::string result; + Teuchos::ArrayView< double const > *arg2 = 0 ; + Teuchos::RCP< Tpetra::MultiVector< SC,LO,GO,NO > > *smartarg1 ; + double const *tempbegin2 ; + Teuchos::ArrayView< double const > temparr2 ; - smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); + smartarg1 = static_cast< Teuchos::RCP< Tpetra::MultiVector >* >(farg1->cptr); arg1 = smartarg1 ? const_cast< Tpetra::MultiVector* >(smartarg1->get()) : NULL; + tempbegin2 = static_cast(farg2->data); + temparr2 = Teuchos::ArrayView(tempbegin2, farg2->size); + arg2 = &temparr2; { // Make sure no unhandled exceptions exist before performing a new action - SWIG_check_unhandled_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::description() const");; + SWIG_check_unhandled_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::scale(Teuchos::ArrayView< double const > const &)");; try { // Attempt the wrapped function call - result = ((Tpetra::MultiVector< SC,LO,GO,NO > const *)arg1)->description(); + (arg1)->scale((Teuchos::ArrayView< double const > const &)*arg2); } catch (const std::range_error& e) { // Store a C++ exception - SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::description() const", SWIG_IndexError, e.what(), return SwigArrayWrapper_uninitialized()); + SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::scale(Teuchos::ArrayView< double const > const &)", SWIG_IndexError, e.what(), return ); } catch (const std::exception& e) { // Store a C++ exception - SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::description() const", SWIG_RuntimeError, e.what(), return SwigArrayWrapper_uninitialized()); + SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::scale(Teuchos::ArrayView< double const > const &)", SWIG_RuntimeError, e.what(), return ); } catch (...) { - SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::description() const", SWIG_UnknownError, "An unknown exception occurred", return SwigArrayWrapper_uninitialized()); + SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::scale(Teuchos::ArrayView< double const > const &)", SWIG_UnknownError, "An unknown exception occurred", return ); } } - fresult.size = (&result)->size(); - if (fresult.size > 0) { - fresult.data = malloc(fresult.size); - memcpy(fresult.data, (&result)->c_str(), fresult.size); - } else { - fresult.data = NULL; + +} + + +SWIGEXPORT void _wrap_TpetraMultiVector_scale__SWIG_2(SwigClassWrapper const *farg1, double const *farg2, SwigClassWrapper const *farg3) { + Tpetra::MultiVector< SC,LO,GO,NO > *arg1 = (Tpetra::MultiVector< SC,LO,GO,NO > *) 0 ; + double *arg2 = 0 ; + Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > *arg3 = 0 ; + Teuchos::RCP< Tpetra::MultiVector< SC,LO,GO,NO > > *smartarg1 ; + double temp2 ; + Teuchos::RCP< Tpetra::MultiVector< SC,LO,GO,NO > const > *smartarg3 ; + + smartarg1 = static_cast< Teuchos::RCP< Tpetra::MultiVector >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::MultiVector* >(smartarg1->get()) : NULL; + temp2 = static_cast< double >(*farg2); + arg2 = &temp2; + SWIG_check_sp_nonnull(farg3, "Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > *", "TpetraMultiVector", "Tpetra::MultiVector< SC,LO,GO,NO >::scale(double const &,Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &)", return ) + smartarg3 = static_cast< Teuchos::RCP >* >(farg3->cptr); + arg3 = const_cast< Tpetra::MultiVector* >(smartarg3->get()); + { + // Make sure no unhandled exceptions exist before performing a new action + SWIG_check_unhandled_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::scale(double const &,Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &)");; + try + { + // Attempt the wrapped function call + (arg1)->scale((double const &)*arg2,(Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &)*arg3); + } + catch (const std::range_error& e) + { + // Store a C++ exception + SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::scale(double const &,Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &)", SWIG_IndexError, e.what(), return ); + } + catch (const std::exception& e) + { + // Store a C++ exception + SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::scale(double const &,Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &)", SWIG_RuntimeError, e.what(), return ); + } + catch (...) + { + SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::scale(double const &,Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &)", SWIG_UnknownError, "An unknown exception occurred", return ); + } } - return fresult; + } -SWIGEXPORT void _wrap_TpetraMultiVector_removeEmptyProcessesInPlace(SwigClassWrapper const *farg1, SwigClassWrapper const *farg2) { +SWIGEXPORT void _wrap_TpetraMultiVector_update__SWIG_0(SwigClassWrapper const *farg1, double const *farg2, SwigClassWrapper const *farg3, double const *farg4) { Tpetra::MultiVector< SC,LO,GO,NO > *arg1 = (Tpetra::MultiVector< SC,LO,GO,NO > *) 0 ; - Teuchos::RCP< Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > *arg2 = 0 ; + double *arg2 = 0 ; + Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > *arg3 = 0 ; + double *arg4 = 0 ; Teuchos::RCP< Tpetra::MultiVector< SC,LO,GO,NO > > *smartarg1 ; - Teuchos::RCP< Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > tempnull2 ; + double temp2 ; + Teuchos::RCP< Tpetra::MultiVector< SC,LO,GO,NO > const > *smartarg3 ; + double temp4 ; smartarg1 = static_cast< Teuchos::RCP< Tpetra::MultiVector >* >(farg1->cptr); arg1 = smartarg1 ? const_cast< Tpetra::MultiVector* >(smartarg1->get()) : NULL; - arg2 = farg2->cptr ? static_cast< Teuchos::RCP< Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg2->cptr) : &tempnull2; + temp2 = static_cast< double >(*farg2); + arg2 = &temp2; + SWIG_check_sp_nonnull(farg3, "Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > *", "TpetraMultiVector", "Tpetra::MultiVector< SC,LO,GO,NO >::update(double const &,Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &,double const &)", return ) + smartarg3 = static_cast< Teuchos::RCP >* >(farg3->cptr); + arg3 = const_cast< Tpetra::MultiVector* >(smartarg3->get()); + temp4 = static_cast< double >(*farg4); + arg4 = &temp4; { // Make sure no unhandled exceptions exist before performing a new action - SWIG_check_unhandled_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::removeEmptyProcessesInPlace(Teuchos::RCP< Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &)");; + SWIG_check_unhandled_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::update(double const &,Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &,double const &)");; try { // Attempt the wrapped function call - (arg1)->removeEmptyProcessesInPlace((Teuchos::RCP< Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &)*arg2); + (arg1)->update((double const &)*arg2,(Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &)*arg3,(double const &)*arg4); } catch (const std::range_error& e) { // Store a C++ exception - SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::removeEmptyProcessesInPlace(Teuchos::RCP< Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &)", SWIG_IndexError, e.what(), return ); + SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::update(double const &,Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &,double const &)", SWIG_IndexError, e.what(), return ); } catch (const std::exception& e) { // Store a C++ exception - SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::removeEmptyProcessesInPlace(Teuchos::RCP< Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &)", SWIG_RuntimeError, e.what(), return ); + SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::update(double const &,Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &,double const &)", SWIG_RuntimeError, e.what(), return ); } catch (...) { - SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::removeEmptyProcessesInPlace(Teuchos::RCP< Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &)", SWIG_UnknownError, "An unknown exception occurred", return ); + SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::update(double const &,Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &,double const &)", SWIG_UnknownError, "An unknown exception occurred", return ); } } } -SWIGEXPORT void _wrap_TpetraMultiVector_setCopyOrView(SwigClassWrapper const *farg1, int const *farg2) { +SWIGEXPORT void _wrap_TpetraMultiVector_update__SWIG_1(SwigClassWrapper const *farg1, double const *farg2, SwigClassWrapper const *farg3, double const *farg4, SwigClassWrapper const *farg5, double const *farg6) { Tpetra::MultiVector< SC,LO,GO,NO > *arg1 = (Tpetra::MultiVector< SC,LO,GO,NO > *) 0 ; - Teuchos::DataAccess arg2 ; + double *arg2 = 0 ; + Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > *arg3 = 0 ; + double *arg4 = 0 ; + Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > *arg5 = 0 ; + double *arg6 = 0 ; Teuchos::RCP< Tpetra::MultiVector< SC,LO,GO,NO > > *smartarg1 ; + double temp2 ; + Teuchos::RCP< Tpetra::MultiVector< SC,LO,GO,NO > const > *smartarg3 ; + double temp4 ; + Teuchos::RCP< Tpetra::MultiVector< SC,LO,GO,NO > const > *smartarg5 ; + double temp6 ; smartarg1 = static_cast< Teuchos::RCP< Tpetra::MultiVector >* >(farg1->cptr); arg1 = smartarg1 ? const_cast< Tpetra::MultiVector* >(smartarg1->get()) : NULL; - arg2 = static_cast< Teuchos::DataAccess >(*farg2); + temp2 = static_cast< double >(*farg2); + arg2 = &temp2; + SWIG_check_sp_nonnull(farg3, "Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > *", "TpetraMultiVector", "Tpetra::MultiVector< SC,LO,GO,NO >::update(double const &,Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &,double const &,Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &,double const &)", return ) + smartarg3 = static_cast< Teuchos::RCP >* >(farg3->cptr); + arg3 = const_cast< Tpetra::MultiVector* >(smartarg3->get()); + temp4 = static_cast< double >(*farg4); + arg4 = &temp4; + SWIG_check_sp_nonnull(farg5, "Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > *", "TpetraMultiVector", "Tpetra::MultiVector< SC,LO,GO,NO >::update(double const &,Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &,double const &,Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &,double const &)", return ) + smartarg5 = static_cast< Teuchos::RCP >* >(farg5->cptr); + arg5 = const_cast< Tpetra::MultiVector* >(smartarg5->get()); + temp6 = static_cast< double >(*farg6); + arg6 = &temp6; { // Make sure no unhandled exceptions exist before performing a new action - SWIG_check_unhandled_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::setCopyOrView(Teuchos::DataAccess const)");; + SWIG_check_unhandled_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::update(double const &,Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &,double const &,Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &,double const &)");; try { // Attempt the wrapped function call - (arg1)->setCopyOrView(arg2); + (arg1)->update((double const &)*arg2,(Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &)*arg3,(double const &)*arg4,(Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &)*arg5,(double const &)*arg6); } catch (const std::range_error& e) { // Store a C++ exception - SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::setCopyOrView(Teuchos::DataAccess const)", SWIG_IndexError, e.what(), return ); + SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::update(double const &,Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &,double const &,Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &,double const &)", SWIG_IndexError, e.what(), return ); } catch (const std::exception& e) { // Store a C++ exception - SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::setCopyOrView(Teuchos::DataAccess const)", SWIG_RuntimeError, e.what(), return ); + SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::update(double const &,Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &,double const &,Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &,double const &)", SWIG_RuntimeError, e.what(), return ); } catch (...) { - SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::setCopyOrView(Teuchos::DataAccess const)", SWIG_UnknownError, "An unknown exception occurred", return ); + SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::update(double const &,Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &,double const &,Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &,double const &)", SWIG_UnknownError, "An unknown exception occurred", return ); } } } -SWIGEXPORT int _wrap_TpetraMultiVector_getCopyOrView(SwigClassWrapper const *farg1) { - int fresult ; +SWIGEXPORT void _wrap_TpetraMultiVector_norm1__SWIG_1(SwigClassWrapper const *farg1, SwigClassWrapper const *farg2) { Tpetra::MultiVector< SC,LO,GO,NO > *arg1 = (Tpetra::MultiVector< SC,LO,GO,NO > *) 0 ; + Kokkos::View< Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::mag_type *,Kokkos::HostSpace > *arg2 = 0 ; Teuchos::RCP< Tpetra::MultiVector< SC,LO,GO,NO > const > *smartarg1 ; - Teuchos::DataAccess result; smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); arg1 = smartarg1 ? const_cast< Tpetra::MultiVector* >(smartarg1->get()) : NULL; + SWIG_check_nonnull(*farg2, "Kokkos::View< Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::mag_type *,Kokkos::HostSpace > const &", "SWIGTYPE_Kokkos__ViewT_double_p_Kokkos__HostSpace_t", "Tpetra::MultiVector< SC,LO,GO,NO >::norm1(Kokkos::View< Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::mag_type *,Kokkos::HostSpace > const &) const", return ); + arg2 = static_cast< Kokkos::View< Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::mag_type *,Kokkos::HostSpace > * >(farg2->cptr); { // Make sure no unhandled exceptions exist before performing a new action - SWIG_check_unhandled_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::getCopyOrView() const");; + SWIG_check_unhandled_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::norm1(Kokkos::View< Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::mag_type *,Kokkos::HostSpace > const &) const");; try { // Attempt the wrapped function call - result = (Teuchos::DataAccess)((Tpetra::MultiVector< SC,LO,GO,NO > const *)arg1)->getCopyOrView(); + ((Tpetra::MultiVector< SC,LO,GO,NO > const *)arg1)->norm1((Kokkos::View< Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::mag_type *,Kokkos::HostSpace > const &)*arg2); } catch (const std::range_error& e) { // Store a C++ exception - SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::getCopyOrView() const", SWIG_IndexError, e.what(), return 0); + SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::norm1(Kokkos::View< Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::mag_type *,Kokkos::HostSpace > const &) const", SWIG_IndexError, e.what(), return ); } catch (const std::exception& e) { // Store a C++ exception - SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::getCopyOrView() const", SWIG_RuntimeError, e.what(), return 0); + SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::norm1(Kokkos::View< Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::mag_type *,Kokkos::HostSpace > const &) const", SWIG_RuntimeError, e.what(), return ); } catch (...) { - SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::getCopyOrView() const", SWIG_UnknownError, "An unknown exception occurred", return 0); + SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::norm1(Kokkos::View< Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::mag_type *,Kokkos::HostSpace > const &) const", SWIG_UnknownError, "An unknown exception occurred", return ); } } - fresult = static_cast< int >(result); - return fresult; + } -SWIGEXPORT int _wrap_TpetraMultiVector_isSameSize(SwigClassWrapper const *farg1, SwigClassWrapper const *farg2) { - int fresult ; +SWIGEXPORT void _wrap_TpetraMultiVector_norm1__SWIG_3(SwigClassWrapper const *farg1, SwigArrayWrapper *farg2) { Tpetra::MultiVector< SC,LO,GO,NO > *arg1 = (Tpetra::MultiVector< SC,LO,GO,NO > *) 0 ; - Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > *arg2 = 0 ; + Teuchos::ArrayView< Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::mag_type > *arg2 = 0 ; Teuchos::RCP< Tpetra::MultiVector< SC,LO,GO,NO > const > *smartarg1 ; - Teuchos::RCP< Tpetra::MultiVector< SC,LO,GO,NO > const > *smartarg2 ; - bool result; + double *tempbegin2 ; + Teuchos::ArrayView< double > temparr2 ; smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); arg1 = smartarg1 ? const_cast< Tpetra::MultiVector* >(smartarg1->get()) : NULL; - SWIG_check_sp_nonnull(farg2, "Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > *", "TpetraMultiVector", "Tpetra::MultiVector< SC,LO,GO,NO >::isSameSize(Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &) const", return 0) - smartarg2 = static_cast< Teuchos::RCP >* >(farg2->cptr); - arg2 = const_cast< Tpetra::MultiVector* >(smartarg2->get()); + tempbegin2 = static_cast(farg2->data); + temparr2 = Teuchos::ArrayView(tempbegin2, farg2->size); + arg2 = &temparr2; { // Make sure no unhandled exceptions exist before performing a new action - SWIG_check_unhandled_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::isSameSize(Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &) const");; + SWIG_check_unhandled_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::norm1(Teuchos::ArrayView< Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::mag_type > const &) const");; try { // Attempt the wrapped function call - result = (bool)((Tpetra::MultiVector< SC,LO,GO,NO > const *)arg1)->isSameSize((Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &)*arg2); + ((Tpetra::MultiVector< SC,LO,GO,NO > const *)arg1)->norm1((Teuchos::ArrayView< Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::mag_type > const &)*arg2); } catch (const std::range_error& e) { // Store a C++ exception - SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::isSameSize(Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &) const", SWIG_IndexError, e.what(), return 0); + SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::norm1(Teuchos::ArrayView< Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::mag_type > const &) const", SWIG_IndexError, e.what(), return ); } catch (const std::exception& e) { // Store a C++ exception - SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::isSameSize(Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &) const", SWIG_RuntimeError, e.what(), return 0); + SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::norm1(Teuchos::ArrayView< Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::mag_type > const &) const", SWIG_RuntimeError, e.what(), return ); } catch (...) { - SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::isSameSize(Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &) const", SWIG_UnknownError, "An unknown exception occurred", return 0); + SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::norm1(Teuchos::ArrayView< Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::mag_type > const &) const", SWIG_UnknownError, "An unknown exception occurred", return ); } } - fresult = (result ? 1 : 0); - return fresult; + } -SWIGEXPORT SwigClassWrapper _wrap_new_TpetraMultiVector__SWIG_8(SwigClassWrapper const *farg1, SwigArrayWrapper *farg2, size_t const *farg3, size_t const *farg4) { - SwigClassWrapper fresult ; - Teuchos::RCP< Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > *arg1 = 0 ; - std::pair< SC const *,std::size_t > arg2 ; - size_t arg3 ; - size_t arg4 ; - Teuchos::RCP< Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > tempnull1 ; - Tpetra::MultiVector< SC,LO,GO,NO > *result = 0 ; +SWIGEXPORT void _wrap_TpetraMultiVector_norm2__SWIG_1(SwigClassWrapper const *farg1, SwigClassWrapper const *farg2) { + Tpetra::MultiVector< SC,LO,GO,NO > *arg1 = (Tpetra::MultiVector< SC,LO,GO,NO > *) 0 ; + Kokkos::View< Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::mag_type *,Kokkos::HostSpace > *arg2 = 0 ; + Teuchos::RCP< Tpetra::MultiVector< SC,LO,GO,NO > const > *smartarg1 ; - arg1 = farg1->cptr ? static_cast< Teuchos::RCP< Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg1->cptr) : &tempnull1; - (&arg2)->first = static_cast(farg2->data); - (&arg2)->second = farg2->size; - arg3 = static_cast< size_t >(*farg3); - arg4 = static_cast< size_t >(*farg4); + smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::MultiVector* >(smartarg1->get()) : NULL; + SWIG_check_nonnull(*farg2, "Kokkos::View< Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::mag_type *,Kokkos::HostSpace > const &", "SWIGTYPE_Kokkos__ViewT_double_p_Kokkos__HostSpace_t", "Tpetra::MultiVector< SC,LO,GO,NO >::norm2(Kokkos::View< Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::mag_type *,Kokkos::HostSpace > const &) const", return ); + arg2 = static_cast< Kokkos::View< Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::mag_type *,Kokkos::HostSpace > * >(farg2->cptr); { // Make sure no unhandled exceptions exist before performing a new action - SWIG_check_unhandled_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::MultiVector(Teuchos::RCP< Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,std::pair< SC const *,std::size_t >,size_t const,size_t const)");; + SWIG_check_unhandled_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::norm2(Kokkos::View< Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::mag_type *,Kokkos::HostSpace > const &) const");; try { // Attempt the wrapped function call - result = (Tpetra::MultiVector< SC,LO,GO,NO > *)new_Tpetra_MultiVector_Sl_SC_Sc_LO_Sc_GO_Sc_NO_Sg___SWIG_8((Teuchos::RCP< Tpetra::Map< int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const > const &)*arg1,arg2,arg3,arg4); + ((Tpetra::MultiVector< SC,LO,GO,NO > const *)arg1)->norm2((Kokkos::View< Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::mag_type *,Kokkos::HostSpace > const &)*arg2); } catch (const std::range_error& e) { // Store a C++ exception - SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::MultiVector(Teuchos::RCP< Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,std::pair< SC const *,std::size_t >,size_t const,size_t const)", SWIG_IndexError, e.what(), return SwigClassWrapper_uninitialized()); + SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::norm2(Kokkos::View< Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::mag_type *,Kokkos::HostSpace > const &) const", SWIG_IndexError, e.what(), return ); } catch (const std::exception& e) { // Store a C++ exception - SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::MultiVector(Teuchos::RCP< Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,std::pair< SC const *,std::size_t >,size_t const,size_t const)", SWIG_RuntimeError, e.what(), return SwigClassWrapper_uninitialized()); + SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::norm2(Kokkos::View< Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::mag_type *,Kokkos::HostSpace > const &) const", SWIG_RuntimeError, e.what(), return ); } catch (...) { - SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::MultiVector(Teuchos::RCP< Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,std::pair< SC const *,std::size_t >,size_t const,size_t const)", SWIG_UnknownError, "An unknown exception occurred", return SwigClassWrapper_uninitialized()); + SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::norm2(Kokkos::View< Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::mag_type *,Kokkos::HostSpace > const &) const", SWIG_UnknownError, "An unknown exception occurred", return ); } } - fresult.cptr = result ? new Teuchos::RCP< Tpetra::MultiVector >(result SWIG_NO_NULL_DELETER_1) : NULL; - fresult.mem = SWIG_MOVE; - return fresult; + } -SWIGEXPORT SwigArrayWrapper _wrap_TpetraMultiVector_getData(SwigClassWrapper const *farg1, size_t const *farg2) { - SwigArrayWrapper fresult ; +SWIGEXPORT void _wrap_TpetraMultiVector_norm2__SWIG_3(SwigClassWrapper const *farg1, SwigArrayWrapper *farg2) { Tpetra::MultiVector< SC,LO,GO,NO > *arg1 = (Tpetra::MultiVector< SC,LO,GO,NO > *) 0 ; - size_t arg2 ; + Teuchos::ArrayView< Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::mag_type > *arg2 = 0 ; Teuchos::RCP< Tpetra::MultiVector< SC,LO,GO,NO > const > *smartarg1 ; - std::pair< SC const *,std::size_t > result; + double *tempbegin2 ; + Teuchos::ArrayView< double > temparr2 ; smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); arg1 = smartarg1 ? const_cast< Tpetra::MultiVector* >(smartarg1->get()) : NULL; - arg2 = *farg2 - 1; + tempbegin2 = static_cast(farg2->data); + temparr2 = Teuchos::ArrayView(tempbegin2, farg2->size); + arg2 = &temparr2; { // Make sure no unhandled exceptions exist before performing a new action - SWIG_check_unhandled_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::getData(size_t) const");; + SWIG_check_unhandled_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::norm2(Teuchos::ArrayView< Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::mag_type > const &) const");; try { // Attempt the wrapped function call - result = Tpetra_MultiVector_Sl_SC_Sc_LO_Sc_GO_Sc_NO_Sg__getData((Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const *)arg1,arg2); + ((Tpetra::MultiVector< SC,LO,GO,NO > const *)arg1)->norm2((Teuchos::ArrayView< Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::mag_type > const &)*arg2); } catch (const std::range_error& e) { // Store a C++ exception - SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::getData(size_t) const", SWIG_IndexError, e.what(), return SwigArrayWrapper_uninitialized()); + SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::norm2(Teuchos::ArrayView< Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::mag_type > const &) const", SWIG_IndexError, e.what(), return ); } catch (const std::exception& e) { // Store a C++ exception - SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::getData(size_t) const", SWIG_RuntimeError, e.what(), return SwigArrayWrapper_uninitialized()); + SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::norm2(Teuchos::ArrayView< Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::mag_type > const &) const", SWIG_RuntimeError, e.what(), return ); } catch (...) { - SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::getData(size_t) const", SWIG_UnknownError, "An unknown exception occurred", return SwigArrayWrapper_uninitialized()); + SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::norm2(Teuchos::ArrayView< Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::mag_type > const &) const", SWIG_UnknownError, "An unknown exception occurred", return ); } } - fresult.data = const_cast((&result)->first); - fresult.size = (&result)->second; - return fresult; + } -SWIGEXPORT SwigArrayWrapper _wrap_TpetraMultiVector_getDataNonConst(SwigClassWrapper const *farg1, size_t const *farg2) { - SwigArrayWrapper fresult ; +SWIGEXPORT void _wrap_TpetraMultiVector_normInf__SWIG_1(SwigClassWrapper const *farg1, SwigClassWrapper const *farg2) { Tpetra::MultiVector< SC,LO,GO,NO > *arg1 = (Tpetra::MultiVector< SC,LO,GO,NO > *) 0 ; - size_t arg2 ; - Teuchos::RCP< Tpetra::MultiVector< SC,LO,GO,NO > > *smartarg1 ; - std::pair< SC *,std::size_t > result; + Kokkos::View< Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::mag_type *,Kokkos::HostSpace > *arg2 = 0 ; + Teuchos::RCP< Tpetra::MultiVector< SC,LO,GO,NO > const > *smartarg1 ; - smartarg1 = static_cast< Teuchos::RCP< Tpetra::MultiVector >* >(farg1->cptr); + smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::MultiVector* >(smartarg1->get()) : NULL; + SWIG_check_nonnull(*farg2, "Kokkos::View< Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::mag_type *,Kokkos::HostSpace > const &", "SWIGTYPE_Kokkos__ViewT_double_p_Kokkos__HostSpace_t", "Tpetra::MultiVector< SC,LO,GO,NO >::normInf(Kokkos::View< Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::mag_type *,Kokkos::HostSpace > const &) const", return ); + arg2 = static_cast< Kokkos::View< Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::mag_type *,Kokkos::HostSpace > * >(farg2->cptr); + { + // Make sure no unhandled exceptions exist before performing a new action + SWIG_check_unhandled_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::normInf(Kokkos::View< Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::mag_type *,Kokkos::HostSpace > const &) const");; + try + { + // Attempt the wrapped function call + ((Tpetra::MultiVector< SC,LO,GO,NO > const *)arg1)->normInf((Kokkos::View< Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::mag_type *,Kokkos::HostSpace > const &)*arg2); + } + catch (const std::range_error& e) + { + // Store a C++ exception + SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::normInf(Kokkos::View< Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::mag_type *,Kokkos::HostSpace > const &) const", SWIG_IndexError, e.what(), return ); + } + catch (const std::exception& e) + { + // Store a C++ exception + SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::normInf(Kokkos::View< Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::mag_type *,Kokkos::HostSpace > const &) const", SWIG_RuntimeError, e.what(), return ); + } + catch (...) + { + SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::normInf(Kokkos::View< Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::mag_type *,Kokkos::HostSpace > const &) const", SWIG_UnknownError, "An unknown exception occurred", return ); + } + } + +} + + +SWIGEXPORT void _wrap_TpetraMultiVector_normInf__SWIG_3(SwigClassWrapper const *farg1, SwigArrayWrapper *farg2) { + Tpetra::MultiVector< SC,LO,GO,NO > *arg1 = (Tpetra::MultiVector< SC,LO,GO,NO > *) 0 ; + Teuchos::ArrayView< Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::mag_type > *arg2 = 0 ; + Teuchos::RCP< Tpetra::MultiVector< SC,LO,GO,NO > const > *smartarg1 ; + double *tempbegin2 ; + Teuchos::ArrayView< double > temparr2 ; + + smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); arg1 = smartarg1 ? const_cast< Tpetra::MultiVector* >(smartarg1->get()) : NULL; - arg2 = *farg2 - 1; + tempbegin2 = static_cast(farg2->data); + temparr2 = Teuchos::ArrayView(tempbegin2, farg2->size); + arg2 = &temparr2; { // Make sure no unhandled exceptions exist before performing a new action - SWIG_check_unhandled_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::getDataNonConst(size_t)");; + SWIG_check_unhandled_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::normInf(Teuchos::ArrayView< Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::mag_type > const &) const");; try { // Attempt the wrapped function call - result = Tpetra_MultiVector_Sl_SC_Sc_LO_Sc_GO_Sc_NO_Sg__getDataNonConst(arg1,arg2); + ((Tpetra::MultiVector< SC,LO,GO,NO > const *)arg1)->normInf((Teuchos::ArrayView< Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::mag_type > const &)*arg2); } catch (const std::range_error& e) { // Store a C++ exception - SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::getDataNonConst(size_t)", SWIG_IndexError, e.what(), return SwigArrayWrapper_uninitialized()); + SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::normInf(Teuchos::ArrayView< Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::mag_type > const &) const", SWIG_IndexError, e.what(), return ); } catch (const std::exception& e) { // Store a C++ exception - SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::getDataNonConst(size_t)", SWIG_RuntimeError, e.what(), return SwigArrayWrapper_uninitialized()); + SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::normInf(Teuchos::ArrayView< Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::mag_type > const &) const", SWIG_RuntimeError, e.what(), return ); } catch (...) { - SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::getDataNonConst(size_t)", SWIG_UnknownError, "An unknown exception occurred", return SwigArrayWrapper_uninitialized()); + SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::normInf(Teuchos::ArrayView< Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::mag_type > const &) const", SWIG_UnknownError, "An unknown exception occurred", return ); } } - fresult.data = (&result)->first; - fresult.size = (&result)->second; - return fresult; + } -SWIGEXPORT SwigClassWrapper _wrap_TpetraMultiVector_subCopy(SwigClassWrapper const *farg1, SwigArrayWrapper *farg2) { - SwigClassWrapper fresult ; +SWIGEXPORT void _wrap_TpetraMultiVector_meanValue(SwigClassWrapper const *farg1, SwigArrayWrapper *farg2) { Tpetra::MultiVector< SC,LO,GO,NO > *arg1 = (Tpetra::MultiVector< SC,LO,GO,NO > *) 0 ; - std::pair< std::size_t const *,std::size_t > arg2 ; + Teuchos::ArrayView< Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::impl_scalar_type > *arg2 = 0 ; Teuchos::RCP< Tpetra::MultiVector< SC,LO,GO,NO > const > *smartarg1 ; - Teuchos::RCP< Tpetra::MultiVector< SC,LO,GO,NO > > result; + double *tempbegin2 ; + Teuchos::ArrayView< double > temparr2 ; smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); arg1 = smartarg1 ? const_cast< Tpetra::MultiVector* >(smartarg1->get()) : NULL; - (&arg2)->first = static_cast(farg2->data); - (&arg2)->second = farg2->size; + tempbegin2 = static_cast(farg2->data); + temparr2 = Teuchos::ArrayView(tempbegin2, farg2->size); + arg2 = &temparr2; { // Make sure no unhandled exceptions exist before performing a new action - SWIG_check_unhandled_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::subCopy(std::pair< std::size_t const *,std::size_t >) const");; + SWIG_check_unhandled_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::meanValue(Teuchos::ArrayView< Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::impl_scalar_type > const &) const");; try { // Attempt the wrapped function call - result = Tpetra_MultiVector_Sl_SC_Sc_LO_Sc_GO_Sc_NO_Sg__subCopy((Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const *)arg1,arg2); + ((Tpetra::MultiVector< SC,LO,GO,NO > const *)arg1)->meanValue((Teuchos::ArrayView< Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::impl_scalar_type > const &)*arg2); } catch (const std::range_error& e) { // Store a C++ exception - SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::subCopy(std::pair< std::size_t const *,std::size_t >) const", SWIG_IndexError, e.what(), return SwigClassWrapper_uninitialized()); + SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::meanValue(Teuchos::ArrayView< Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::impl_scalar_type > const &) const", SWIG_IndexError, e.what(), return ); } catch (const std::exception& e) { // Store a C++ exception - SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::subCopy(std::pair< std::size_t const *,std::size_t >) const", SWIG_RuntimeError, e.what(), return SwigClassWrapper_uninitialized()); + SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::meanValue(Teuchos::ArrayView< Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::impl_scalar_type > const &) const", SWIG_RuntimeError, e.what(), return ); } catch (...) { - SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::subCopy(std::pair< std::size_t const *,std::size_t >) const", SWIG_UnknownError, "An unknown exception occurred", return SwigClassWrapper_uninitialized()); + SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::meanValue(Teuchos::ArrayView< Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::impl_scalar_type > const &) const", SWIG_UnknownError, "An unknown exception occurred", return ); } } - fresult.cptr = (new Teuchos::RCP< Tpetra::MultiVector >(static_cast< const Teuchos::RCP< Tpetra::MultiVector >& >(result))); - fresult.mem = SWIG_MOVE; - return fresult; + } -SWIGEXPORT SwigClassWrapper _wrap_TpetraMultiVector_subView(SwigClassWrapper const *farg1, SwigArrayWrapper *farg2) { - SwigClassWrapper fresult ; +SWIGEXPORT void _wrap_TpetraMultiVector_multiply(SwigClassWrapper const *farg1, int const *farg2, int const *farg3, double const *farg4, SwigClassWrapper const *farg5, SwigClassWrapper const *farg6, double const *farg7) { Tpetra::MultiVector< SC,LO,GO,NO > *arg1 = (Tpetra::MultiVector< SC,LO,GO,NO > *) 0 ; - std::pair< std::size_t const *,std::size_t > arg2 ; - Teuchos::RCP< Tpetra::MultiVector< SC,LO,GO,NO > const > *smartarg1 ; - Teuchos::RCP< Tpetra::MultiVector< SC,LO,GO,NO > const > result; + Teuchos::ETransp arg2 ; + Teuchos::ETransp arg3 ; + double *arg4 = 0 ; + Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > *arg5 = 0 ; + Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > *arg6 = 0 ; + double *arg7 = 0 ; + Teuchos::RCP< Tpetra::MultiVector< SC,LO,GO,NO > > *smartarg1 ; + double temp4 ; + Teuchos::RCP< Tpetra::MultiVector< SC,LO,GO,NO > const > *smartarg5 ; + Teuchos::RCP< Tpetra::MultiVector< SC,LO,GO,NO > const > *smartarg6 ; + double temp7 ; - smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); + smartarg1 = static_cast< Teuchos::RCP< Tpetra::MultiVector >* >(farg1->cptr); arg1 = smartarg1 ? const_cast< Tpetra::MultiVector* >(smartarg1->get()) : NULL; - (&arg2)->first = static_cast(farg2->data); - (&arg2)->second = farg2->size; + arg2 = static_cast< Teuchos::ETransp >(*farg2); + arg3 = static_cast< Teuchos::ETransp >(*farg3); + temp4 = static_cast< double >(*farg4); + arg4 = &temp4; + SWIG_check_sp_nonnull(farg5, "Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > *", "TpetraMultiVector", "Tpetra::MultiVector< SC,LO,GO,NO >::multiply(Teuchos::ETransp,Teuchos::ETransp,double const &,Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &,Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &,double const &)", return ) + smartarg5 = static_cast< Teuchos::RCP >* >(farg5->cptr); + arg5 = const_cast< Tpetra::MultiVector* >(smartarg5->get()); + SWIG_check_sp_nonnull(farg6, "Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > *", "TpetraMultiVector", "Tpetra::MultiVector< SC,LO,GO,NO >::multiply(Teuchos::ETransp,Teuchos::ETransp,double const &,Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &,Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &,double const &)", return ) + smartarg6 = static_cast< Teuchos::RCP >* >(farg6->cptr); + arg6 = const_cast< Tpetra::MultiVector* >(smartarg6->get()); + temp7 = static_cast< double >(*farg7); + arg7 = &temp7; { // Make sure no unhandled exceptions exist before performing a new action - SWIG_check_unhandled_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::subView(std::pair< std::size_t const *,std::size_t >) const");; + SWIG_check_unhandled_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::multiply(Teuchos::ETransp,Teuchos::ETransp,double const &,Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &,Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &,double const &)");; try { // Attempt the wrapped function call - result = Tpetra_MultiVector_Sl_SC_Sc_LO_Sc_GO_Sc_NO_Sg__subView((Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const *)arg1,arg2); + (arg1)->multiply(arg2,arg3,(double const &)*arg4,(Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &)*arg5,(Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &)*arg6,(double const &)*arg7); } catch (const std::range_error& e) { // Store a C++ exception - SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::subView(std::pair< std::size_t const *,std::size_t >) const", SWIG_IndexError, e.what(), return SwigClassWrapper_uninitialized()); + SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::multiply(Teuchos::ETransp,Teuchos::ETransp,double const &,Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &,Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &,double const &)", SWIG_IndexError, e.what(), return ); } catch (const std::exception& e) { // Store a C++ exception - SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::subView(std::pair< std::size_t const *,std::size_t >) const", SWIG_RuntimeError, e.what(), return SwigClassWrapper_uninitialized()); + SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::multiply(Teuchos::ETransp,Teuchos::ETransp,double const &,Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &,Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &,double const &)", SWIG_RuntimeError, e.what(), return ); } catch (...) { - SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::subView(std::pair< std::size_t const *,std::size_t >) const", SWIG_UnknownError, "An unknown exception occurred", return SwigClassWrapper_uninitialized()); + SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::multiply(Teuchos::ETransp,Teuchos::ETransp,double const &,Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &,Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &,double const &)", SWIG_UnknownError, "An unknown exception occurred", return ); } } - fresult.cptr = (new Teuchos::RCP >(static_cast< const Teuchos::RCP >& >(result))); - fresult.mem = SWIG_MOVE; - return fresult; + } -SWIGEXPORT SwigClassWrapper _wrap_TpetraMultiVector_subViewNonConst(SwigClassWrapper const *farg1, SwigArrayWrapper *farg2) { - SwigClassWrapper fresult ; +SWIGEXPORT size_t _wrap_TpetraMultiVector_getNumVectors(SwigClassWrapper const *farg1) { + size_t fresult ; Tpetra::MultiVector< SC,LO,GO,NO > *arg1 = (Tpetra::MultiVector< SC,LO,GO,NO > *) 0 ; - std::pair< std::size_t const *,std::size_t > arg2 ; - Teuchos::RCP< Tpetra::MultiVector< SC,LO,GO,NO > > *smartarg1 ; - Teuchos::RCP< Tpetra::MultiVector< SC,LO,GO,NO > > result; + Teuchos::RCP< Tpetra::MultiVector< SC,LO,GO,NO > const > *smartarg1 ; + size_t result; - smartarg1 = static_cast< Teuchos::RCP< Tpetra::MultiVector >* >(farg1->cptr); + smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); arg1 = smartarg1 ? const_cast< Tpetra::MultiVector* >(smartarg1->get()) : NULL; - (&arg2)->first = static_cast(farg2->data); - (&arg2)->second = farg2->size; { // Make sure no unhandled exceptions exist before performing a new action - SWIG_check_unhandled_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::subViewNonConst(std::pair< std::size_t const *,std::size_t >)");; + SWIG_check_unhandled_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::getNumVectors() const");; try { // Attempt the wrapped function call - result = Tpetra_MultiVector_Sl_SC_Sc_LO_Sc_GO_Sc_NO_Sg__subViewNonConst(arg1,arg2); + result = (size_t)((Tpetra::MultiVector< SC,LO,GO,NO > const *)arg1)->getNumVectors(); } catch (const std::range_error& e) { // Store a C++ exception - SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::subViewNonConst(std::pair< std::size_t const *,std::size_t >)", SWIG_IndexError, e.what(), return SwigClassWrapper_uninitialized()); + SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::getNumVectors() const", SWIG_IndexError, e.what(), return 0); } catch (const std::exception& e) { // Store a C++ exception - SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::subViewNonConst(std::pair< std::size_t const *,std::size_t >)", SWIG_RuntimeError, e.what(), return SwigClassWrapper_uninitialized()); + SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::getNumVectors() const", SWIG_RuntimeError, e.what(), return 0); } catch (...) { - SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::subViewNonConst(std::pair< std::size_t const *,std::size_t >)", SWIG_UnknownError, "An unknown exception occurred", return SwigClassWrapper_uninitialized()); + SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::getNumVectors() const", SWIG_UnknownError, "An unknown exception occurred", return 0); } } - fresult.cptr = (new Teuchos::RCP< Tpetra::MultiVector >(static_cast< const Teuchos::RCP< Tpetra::MultiVector >& >(result))); - fresult.mem = SWIG_MOVE; + fresult = static_cast< size_t >(result); return fresult; } -SWIGEXPORT void _wrap_TpetraMultiVector_dot(SwigClassWrapper const *farg1, SwigClassWrapper const *farg2, SwigArrayWrapper *farg3) { +SWIGEXPORT size_t _wrap_TpetraMultiVector_getLocalLength(SwigClassWrapper const *farg1) { + size_t fresult ; Tpetra::MultiVector< SC,LO,GO,NO > *arg1 = (Tpetra::MultiVector< SC,LO,GO,NO > *) 0 ; - Tpetra::MultiVector< SC,LO,GO,NO > *arg2 = 0 ; - std::pair< SC *,std::size_t > arg3 ; Teuchos::RCP< Tpetra::MultiVector< SC,LO,GO,NO > const > *smartarg1 ; - Teuchos::RCP< Tpetra::MultiVector< SC,LO,GO,NO > const > *smartarg2 ; + size_t result; smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); arg1 = smartarg1 ? const_cast< Tpetra::MultiVector* >(smartarg1->get()) : NULL; - SWIG_check_sp_nonnull(farg2, "Tpetra::MultiVector< SC,LO,GO,NO > *", "TpetraMultiVector", "Tpetra::MultiVector< SC,LO,GO,NO >::dot(Tpetra::MultiVector< SC,LO,GO,NO > const &,std::pair< SC *,std::size_t >) const", return ) - smartarg2 = static_cast< Teuchos::RCP >* >(farg2->cptr); - arg2 = const_cast< Tpetra::MultiVector* >(smartarg2->get()); - (&arg3)->first = static_cast(farg3->data); - (&arg3)->second = farg3->size; { // Make sure no unhandled exceptions exist before performing a new action - SWIG_check_unhandled_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::dot(Tpetra::MultiVector< SC,LO,GO,NO > const &,std::pair< SC *,std::size_t >) const");; + SWIG_check_unhandled_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::getLocalLength() const");; try { // Attempt the wrapped function call - Tpetra_MultiVector_Sl_SC_Sc_LO_Sc_GO_Sc_NO_Sg__dot((Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const *)arg1,(Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &)*arg2,arg3); + result = (size_t)((Tpetra::MultiVector< SC,LO,GO,NO > const *)arg1)->getLocalLength(); } catch (const std::range_error& e) { // Store a C++ exception - SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::dot(Tpetra::MultiVector< SC,LO,GO,NO > const &,std::pair< SC *,std::size_t >) const", SWIG_IndexError, e.what(), return ); + SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::getLocalLength() const", SWIG_IndexError, e.what(), return 0); } catch (const std::exception& e) { // Store a C++ exception - SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::dot(Tpetra::MultiVector< SC,LO,GO,NO > const &,std::pair< SC *,std::size_t >) const", SWIG_RuntimeError, e.what(), return ); + SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::getLocalLength() const", SWIG_RuntimeError, e.what(), return 0); } catch (...) { - SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::dot(Tpetra::MultiVector< SC,LO,GO,NO > const &,std::pair< SC *,std::size_t >) const", SWIG_UnknownError, "An unknown exception occurred", return ); + SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::getLocalLength() const", SWIG_UnknownError, "An unknown exception occurred", return 0); } } - + fresult = static_cast< size_t >(result); + return fresult; } -SWIGEXPORT void _wrap_TpetraMultiVector_norm1(SwigClassWrapper const *farg1, SwigArrayWrapper *farg2) { +SWIGEXPORT long _wrap_TpetraMultiVector_getGlobalLength(SwigClassWrapper const *farg1) { + long fresult ; Tpetra::MultiVector< SC,LO,GO,NO > *arg1 = (Tpetra::MultiVector< SC,LO,GO,NO > *) 0 ; - std::pair< SC *,std::size_t > arg2 ; Teuchos::RCP< Tpetra::MultiVector< SC,LO,GO,NO > const > *smartarg1 ; + Tpetra::global_size_t result; smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); arg1 = smartarg1 ? const_cast< Tpetra::MultiVector* >(smartarg1->get()) : NULL; - (&arg2)->first = static_cast(farg2->data); - (&arg2)->second = farg2->size; { // Make sure no unhandled exceptions exist before performing a new action - SWIG_check_unhandled_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::norm1(std::pair< SC *,std::size_t >) const");; + SWIG_check_unhandled_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::getGlobalLength() const");; try { // Attempt the wrapped function call - Tpetra_MultiVector_Sl_SC_Sc_LO_Sc_GO_Sc_NO_Sg__norm1((Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const *)arg1,arg2); + result = (Tpetra::global_size_t)((Tpetra::MultiVector< SC,LO,GO,NO > const *)arg1)->getGlobalLength(); } catch (const std::range_error& e) { // Store a C++ exception - SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::norm1(std::pair< SC *,std::size_t >) const", SWIG_IndexError, e.what(), return ); + SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::getGlobalLength() const", SWIG_IndexError, e.what(), return 0); } catch (const std::exception& e) { // Store a C++ exception - SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::norm1(std::pair< SC *,std::size_t >) const", SWIG_RuntimeError, e.what(), return ); + SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::getGlobalLength() const", SWIG_RuntimeError, e.what(), return 0); } catch (...) { - SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::norm1(std::pair< SC *,std::size_t >) const", SWIG_UnknownError, "An unknown exception occurred", return ); + SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::getGlobalLength() const", SWIG_UnknownError, "An unknown exception occurred", return 0); } } - + fresult = static_cast< Tpetra::global_size_t >(result); + return fresult; } -SWIGEXPORT void _wrap_TpetraMultiVector_norm2(SwigClassWrapper const *farg1, SwigArrayWrapper *farg2) { +SWIGEXPORT size_t _wrap_TpetraMultiVector_getStride(SwigClassWrapper const *farg1) { + size_t fresult ; Tpetra::MultiVector< SC,LO,GO,NO > *arg1 = (Tpetra::MultiVector< SC,LO,GO,NO > *) 0 ; - std::pair< SC *,std::size_t > arg2 ; Teuchos::RCP< Tpetra::MultiVector< SC,LO,GO,NO > const > *smartarg1 ; + size_t result; smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); arg1 = smartarg1 ? const_cast< Tpetra::MultiVector* >(smartarg1->get()) : NULL; - (&arg2)->first = static_cast(farg2->data); - (&arg2)->second = farg2->size; { // Make sure no unhandled exceptions exist before performing a new action - SWIG_check_unhandled_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::norm2(std::pair< SC *,std::size_t >) const");; + SWIG_check_unhandled_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::getStride() const");; try { // Attempt the wrapped function call - Tpetra_MultiVector_Sl_SC_Sc_LO_Sc_GO_Sc_NO_Sg__norm2((Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const *)arg1,arg2); + result = (size_t)((Tpetra::MultiVector< SC,LO,GO,NO > const *)arg1)->getStride(); } catch (const std::range_error& e) { // Store a C++ exception - SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::norm2(std::pair< SC *,std::size_t >) const", SWIG_IndexError, e.what(), return ); + SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::getStride() const", SWIG_IndexError, e.what(), return 0); } catch (const std::exception& e) { // Store a C++ exception - SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::norm2(std::pair< SC *,std::size_t >) const", SWIG_RuntimeError, e.what(), return ); + SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::getStride() const", SWIG_RuntimeError, e.what(), return 0); } catch (...) { - SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::norm2(std::pair< SC *,std::size_t >) const", SWIG_UnknownError, "An unknown exception occurred", return ); + SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::getStride() const", SWIG_UnknownError, "An unknown exception occurred", return 0); } } - + fresult = static_cast< size_t >(result); + return fresult; } -SWIGEXPORT void _wrap_TpetraMultiVector_normInf(SwigClassWrapper const *farg1, SwigArrayWrapper *farg2) { +SWIGEXPORT int _wrap_TpetraMultiVector_isConstantStride(SwigClassWrapper const *farg1) { + int fresult ; Tpetra::MultiVector< SC,LO,GO,NO > *arg1 = (Tpetra::MultiVector< SC,LO,GO,NO > *) 0 ; - std::pair< SC *,std::size_t > arg2 ; Teuchos::RCP< Tpetra::MultiVector< SC,LO,GO,NO > const > *smartarg1 ; + bool result; smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); arg1 = smartarg1 ? const_cast< Tpetra::MultiVector* >(smartarg1->get()) : NULL; - (&arg2)->first = static_cast(farg2->data); - (&arg2)->second = farg2->size; { // Make sure no unhandled exceptions exist before performing a new action - SWIG_check_unhandled_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::normInf(std::pair< SC *,std::size_t >) const");; + SWIG_check_unhandled_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::isConstantStride() const");; try { // Attempt the wrapped function call - Tpetra_MultiVector_Sl_SC_Sc_LO_Sc_GO_Sc_NO_Sg__normInf((Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const *)arg1,arg2); + result = (bool)((Tpetra::MultiVector< SC,LO,GO,NO > const *)arg1)->isConstantStride(); } catch (const std::range_error& e) { // Store a C++ exception - SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::normInf(std::pair< SC *,std::size_t >) const", SWIG_IndexError, e.what(), return ); + SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::isConstantStride() const", SWIG_IndexError, e.what(), return 0); } catch (const std::exception& e) { // Store a C++ exception - SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::normInf(std::pair< SC *,std::size_t >) const", SWIG_RuntimeError, e.what(), return ); + SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::isConstantStride() const", SWIG_RuntimeError, e.what(), return 0); } catch (...) { - SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::normInf(std::pair< SC *,std::size_t >) const", SWIG_UnknownError, "An unknown exception occurred", return ); + SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::isConstantStride() const", SWIG_UnknownError, "An unknown exception occurred", return 0); } } - + fresult = (result ? 1 : 0); + return fresult; } -SWIGEXPORT void _wrap_TpetraMultiVector_scale__SWIG_2(SwigClassWrapper const *farg1, SwigArrayWrapper *farg2) { +SWIGEXPORT SwigArrayWrapper _wrap_TpetraMultiVector_description(SwigClassWrapper const *farg1) { + SwigArrayWrapper fresult ; Tpetra::MultiVector< SC,LO,GO,NO > *arg1 = (Tpetra::MultiVector< SC,LO,GO,NO > *) 0 ; - std::pair< SC const *,std::size_t > arg2 ; - Teuchos::RCP< Tpetra::MultiVector< SC,LO,GO,NO > > *smartarg1 ; + Teuchos::RCP< Tpetra::MultiVector< SC,LO,GO,NO > const > *smartarg1 ; + std::string result; - smartarg1 = static_cast< Teuchos::RCP< Tpetra::MultiVector >* >(farg1->cptr); + smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); arg1 = smartarg1 ? const_cast< Tpetra::MultiVector* >(smartarg1->get()) : NULL; - (&arg2)->first = static_cast(farg2->data); - (&arg2)->second = farg2->size; { // Make sure no unhandled exceptions exist before performing a new action - SWIG_check_unhandled_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::scale(std::pair< SC const *,std::size_t >)");; + SWIG_check_unhandled_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::description() const");; try { // Attempt the wrapped function call - Tpetra_MultiVector_Sl_SC_Sc_LO_Sc_GO_Sc_NO_Sg__scale__SWIG_2(arg1,arg2); + result = ((Tpetra::MultiVector< SC,LO,GO,NO > const *)arg1)->description(); } catch (const std::range_error& e) { // Store a C++ exception - SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::scale(std::pair< SC const *,std::size_t >)", SWIG_IndexError, e.what(), return ); + SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::description() const", SWIG_IndexError, e.what(), return SwigArrayWrapper_uninitialized()); } catch (const std::exception& e) { // Store a C++ exception - SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::scale(std::pair< SC const *,std::size_t >)", SWIG_RuntimeError, e.what(), return ); + SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::description() const", SWIG_RuntimeError, e.what(), return SwigArrayWrapper_uninitialized()); } catch (...) { - SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::scale(std::pair< SC const *,std::size_t >)", SWIG_UnknownError, "An unknown exception occurred", return ); + SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::description() const", SWIG_UnknownError, "An unknown exception occurred", return SwigArrayWrapper_uninitialized()); } } - + fresult.size = (&result)->size(); + if (fresult.size > 0) { + fresult.data = malloc(fresult.size); + memcpy(fresult.data, (&result)->c_str(), fresult.size); + } else { + fresult.data = NULL; + } + return fresult; } -SWIGEXPORT void _wrap_TpetraMultiVector_meanValue(SwigClassWrapper const *farg1, SwigArrayWrapper *farg2) { +SWIGEXPORT void _wrap_TpetraMultiVector_removeEmptyProcessesInPlace(SwigClassWrapper const *farg1, SwigClassWrapper const *farg2) { Tpetra::MultiVector< SC,LO,GO,NO > *arg1 = (Tpetra::MultiVector< SC,LO,GO,NO > *) 0 ; - std::pair< SC *,std::size_t > arg2 ; - Teuchos::RCP< Tpetra::MultiVector< SC,LO,GO,NO > const > *smartarg1 ; + Teuchos::RCP< Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > *arg2 = 0 ; + Teuchos::RCP< Tpetra::MultiVector< SC,LO,GO,NO > > *smartarg1 ; + Teuchos::RCP< Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > tempnull2 ; - smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); + smartarg1 = static_cast< Teuchos::RCP< Tpetra::MultiVector >* >(farg1->cptr); arg1 = smartarg1 ? const_cast< Tpetra::MultiVector* >(smartarg1->get()) : NULL; - (&arg2)->first = static_cast(farg2->data); - (&arg2)->second = farg2->size; + arg2 = farg2->cptr ? static_cast< Teuchos::RCP< Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg2->cptr) : &tempnull2; { // Make sure no unhandled exceptions exist before performing a new action - SWIG_check_unhandled_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::meanValue(std::pair< SC *,std::size_t >) const");; + SWIG_check_unhandled_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::removeEmptyProcessesInPlace(Teuchos::RCP< Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &)");; try { // Attempt the wrapped function call - Tpetra_MultiVector_Sl_SC_Sc_LO_Sc_GO_Sc_NO_Sg__meanValue((Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const *)arg1,arg2); + (arg1)->removeEmptyProcessesInPlace((Teuchos::RCP< Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &)*arg2); } catch (const std::range_error& e) { // Store a C++ exception - SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::meanValue(std::pair< SC *,std::size_t >) const", SWIG_IndexError, e.what(), return ); + SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::removeEmptyProcessesInPlace(Teuchos::RCP< Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &)", SWIG_IndexError, e.what(), return ); } catch (const std::exception& e) { // Store a C++ exception - SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::meanValue(std::pair< SC *,std::size_t >) const", SWIG_RuntimeError, e.what(), return ); + SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::removeEmptyProcessesInPlace(Teuchos::RCP< Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &)", SWIG_RuntimeError, e.what(), return ); } catch (...) { - SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::meanValue(std::pair< SC *,std::size_t >) const", SWIG_UnknownError, "An unknown exception occurred", return ); + SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::removeEmptyProcessesInPlace(Teuchos::RCP< Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &)", SWIG_UnknownError, "An unknown exception occurred", return ); } } } -SWIGEXPORT void _wrap_TpetraMultiVector_get1dCopy(SwigClassWrapper const *farg1, SwigArrayWrapper *farg2, size_t const *farg3) { +SWIGEXPORT void _wrap_TpetraMultiVector_setCopyOrView(SwigClassWrapper const *farg1, int const *farg2) { Tpetra::MultiVector< SC,LO,GO,NO > *arg1 = (Tpetra::MultiVector< SC,LO,GO,NO > *) 0 ; - std::pair< SC *,std::size_t > arg2 ; - size_t arg3 ; - Teuchos::RCP< Tpetra::MultiVector< SC,LO,GO,NO > const > *smartarg1 ; + Teuchos::DataAccess arg2 ; + Teuchos::RCP< Tpetra::MultiVector< SC,LO,GO,NO > > *smartarg1 ; - smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); + smartarg1 = static_cast< Teuchos::RCP< Tpetra::MultiVector >* >(farg1->cptr); arg1 = smartarg1 ? const_cast< Tpetra::MultiVector* >(smartarg1->get()) : NULL; - (&arg2)->first = static_cast(farg2->data); - (&arg2)->second = farg2->size; - arg3 = static_cast< size_t >(*farg3); + arg2 = static_cast< Teuchos::DataAccess >(*farg2); { // Make sure no unhandled exceptions exist before performing a new action - SWIG_check_unhandled_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::get1dCopy(std::pair< SC *,std::size_t >,size_t const) const");; + SWIG_check_unhandled_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::setCopyOrView(Teuchos::DataAccess const)");; try { // Attempt the wrapped function call - Tpetra_MultiVector_Sl_SC_Sc_LO_Sc_GO_Sc_NO_Sg__get1dCopy((Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const *)arg1,arg2,arg3); + (arg1)->setCopyOrView(arg2); } catch (const std::range_error& e) { // Store a C++ exception - SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::get1dCopy(std::pair< SC *,std::size_t >,size_t const) const", SWIG_IndexError, e.what(), return ); + SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::setCopyOrView(Teuchos::DataAccess const)", SWIG_IndexError, e.what(), return ); } catch (const std::exception& e) { // Store a C++ exception - SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::get1dCopy(std::pair< SC *,std::size_t >,size_t const) const", SWIG_RuntimeError, e.what(), return ); + SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::setCopyOrView(Teuchos::DataAccess const)", SWIG_RuntimeError, e.what(), return ); } catch (...) { - SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::get1dCopy(std::pair< SC *,std::size_t >,size_t const) const", SWIG_UnknownError, "An unknown exception occurred", return ); + SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::setCopyOrView(Teuchos::DataAccess const)", SWIG_UnknownError, "An unknown exception occurred", return ); } } } -SWIGEXPORT SwigArrayWrapper _wrap_TpetraMultiVector_get1dView(SwigClassWrapper const *farg1) { - SwigArrayWrapper fresult ; +SWIGEXPORT int _wrap_TpetraMultiVector_getCopyOrView(SwigClassWrapper const *farg1) { + int fresult ; Tpetra::MultiVector< SC,LO,GO,NO > *arg1 = (Tpetra::MultiVector< SC,LO,GO,NO > *) 0 ; Teuchos::RCP< Tpetra::MultiVector< SC,LO,GO,NO > const > *smartarg1 ; - std::pair< SC const *,std::size_t > result; + Teuchos::DataAccess result; smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); arg1 = smartarg1 ? const_cast< Tpetra::MultiVector* >(smartarg1->get()) : NULL; { // Make sure no unhandled exceptions exist before performing a new action - SWIG_check_unhandled_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::get1dView() const");; + SWIG_check_unhandled_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::getCopyOrView() const");; try { // Attempt the wrapped function call - result = Tpetra_MultiVector_Sl_SC_Sc_LO_Sc_GO_Sc_NO_Sg__get1dView((Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const *)arg1); + result = (Teuchos::DataAccess)((Tpetra::MultiVector< SC,LO,GO,NO > const *)arg1)->getCopyOrView(); } catch (const std::range_error& e) { // Store a C++ exception - SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::get1dView() const", SWIG_IndexError, e.what(), return SwigArrayWrapper_uninitialized()); + SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::getCopyOrView() const", SWIG_IndexError, e.what(), return 0); } catch (const std::exception& e) { // Store a C++ exception - SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::get1dView() const", SWIG_RuntimeError, e.what(), return SwigArrayWrapper_uninitialized()); + SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::getCopyOrView() const", SWIG_RuntimeError, e.what(), return 0); } catch (...) { - SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::get1dView() const", SWIG_UnknownError, "An unknown exception occurred", return SwigArrayWrapper_uninitialized()); + SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::getCopyOrView() const", SWIG_UnknownError, "An unknown exception occurred", return 0); } } - fresult.data = const_cast((&result)->first); - fresult.size = (&result)->second; + fresult = static_cast< int >(result); return fresult; } -SWIGEXPORT SwigArrayWrapper _wrap_TpetraMultiVector_get1dViewNonConst(SwigClassWrapper const *farg1) { - SwigArrayWrapper fresult ; +SWIGEXPORT int _wrap_TpetraMultiVector_isSameSize(SwigClassWrapper const *farg1, SwigClassWrapper const *farg2) { + int fresult ; Tpetra::MultiVector< SC,LO,GO,NO > *arg1 = (Tpetra::MultiVector< SC,LO,GO,NO > *) 0 ; - Teuchos::RCP< Tpetra::MultiVector< SC,LO,GO,NO > > *smartarg1 ; - std::pair< SC *,std::size_t > result; + Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > *arg2 = 0 ; + Teuchos::RCP< Tpetra::MultiVector< SC,LO,GO,NO > const > *smartarg1 ; + Teuchos::RCP< Tpetra::MultiVector< SC,LO,GO,NO > const > *smartarg2 ; + bool result; - smartarg1 = static_cast< Teuchos::RCP< Tpetra::MultiVector >* >(farg1->cptr); + smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); arg1 = smartarg1 ? const_cast< Tpetra::MultiVector* >(smartarg1->get()) : NULL; + SWIG_check_sp_nonnull(farg2, "Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > *", "TpetraMultiVector", "Tpetra::MultiVector< SC,LO,GO,NO >::isSameSize(Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &) const", return 0) + smartarg2 = static_cast< Teuchos::RCP >* >(farg2->cptr); + arg2 = const_cast< Tpetra::MultiVector* >(smartarg2->get()); { // Make sure no unhandled exceptions exist before performing a new action - SWIG_check_unhandled_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::get1dViewNonConst()");; + SWIG_check_unhandled_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::isSameSize(Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &) const");; try { // Attempt the wrapped function call - result = Tpetra_MultiVector_Sl_SC_Sc_LO_Sc_GO_Sc_NO_Sg__get1dViewNonConst(arg1); + result = (bool)((Tpetra::MultiVector< SC,LO,GO,NO > const *)arg1)->isSameSize((Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &)*arg2); } catch (const std::range_error& e) { // Store a C++ exception - SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::get1dViewNonConst()", SWIG_IndexError, e.what(), return SwigArrayWrapper_uninitialized()); + SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::isSameSize(Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &) const", SWIG_IndexError, e.what(), return 0); } catch (const std::exception& e) { // Store a C++ exception - SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::get1dViewNonConst()", SWIG_RuntimeError, e.what(), return SwigArrayWrapper_uninitialized()); + SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::isSameSize(Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &) const", SWIG_RuntimeError, e.what(), return 0); } catch (...) { - SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::get1dViewNonConst()", SWIG_UnknownError, "An unknown exception occurred", return SwigArrayWrapper_uninitialized()); + SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::isSameSize(Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &) const", SWIG_UnknownError, "An unknown exception occurred", return 0); } } - fresult.data = (&result)->first; - fresult.size = (&result)->second; + fresult = (result ? 1 : 0); return fresult; } @@ -6011,43 +6124,6 @@ SWIGEXPORT void _wrap_TpetraMultiVector_doExport__SWIG_1(SwigClassWrapper const } -SWIGEXPORT SwigClassWrapper _wrap_TpetraMultiVector_getMap(SwigClassWrapper const *farg1) { - SwigClassWrapper fresult ; - Tpetra::MultiVector< SC,LO,GO,NO > *arg1 = (Tpetra::MultiVector< SC,LO,GO,NO > *) 0 ; - Teuchos::RCP< Tpetra::MultiVector< SC,LO,GO,NO > const > *smartarg1 ; - Teuchos::RCP< Tpetra::Map< LO,GO,NO > const > result; - - smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); - arg1 = smartarg1 ? const_cast< Tpetra::MultiVector* >(smartarg1->get()) : NULL; - { - // Make sure no unhandled exceptions exist before performing a new action - SWIG_check_unhandled_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::getMap() const");; - try - { - // Attempt the wrapped function call - result = Tpetra_MultiVector_Sl_SC_Sc_LO_Sc_GO_Sc_NO_Sg__getMap((Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const *)arg1); - } - catch (const std::range_error& e) - { - // Store a C++ exception - SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::getMap() const", SWIG_IndexError, e.what(), return SwigClassWrapper_uninitialized()); - } - catch (const std::exception& e) - { - // Store a C++ exception - SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::getMap() const", SWIG_RuntimeError, e.what(), return SwigClassWrapper_uninitialized()); - } - catch (...) - { - SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::getMap() const", SWIG_UnknownError, "An unknown exception occurred", return SwigClassWrapper_uninitialized()); - } - } - fresult.cptr = (new Teuchos::RCP >(static_cast< const Teuchos::RCP >& >(result))); - fresult.mem = SWIG_MOVE; - return fresult; -} - - SWIGEXPORT void _wrap_assign_TpetraMultiVector(SwigClassWrapper * self, SwigClassWrapper const * other) { typedef Teuchos::RCP< Tpetra::MultiVector > swig_lhs_classtype; SWIG_assign(swig_lhs_classtype, self, @@ -10056,7 +10132,7 @@ SWIGEXPORT void _wrap_TpetraCrsGraph_getLocalRowCopy(SwigClassWrapper const *far } -SWIGEXPORT void _wrap_TpetraCrsGraph_getgblRowView(SwigClassWrapper const *farg1, long long const *farg2, SwigArrayWrapper *farg3) { +SWIGEXPORT void _wrap_TpetraCrsGraph_getGlobalRowView(SwigClassWrapper const *farg1, long long const *farg2, SwigArrayWrapper *farg3) { Tpetra::CrsGraph< LO,GO,NO > *arg1 = (Tpetra::CrsGraph< LO,GO,NO > *) 0 ; GO arg2 ; std::pair< GO const *,std::size_t > arg3 ; @@ -10069,25 +10145,25 @@ SWIGEXPORT void _wrap_TpetraCrsGraph_getgblRowView(SwigClassWrapper const *farg1 (&arg3)->second = farg3->size; { // Make sure no unhandled exceptions exist before performing a new action - SWIG_check_unhandled_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::getgblRowView(GO const,std::pair< GO const *,std::size_t >) const");; + SWIG_check_unhandled_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::getGlobalRowView(GO const,std::pair< GO const *,std::size_t >) const");; try { // Attempt the wrapped function call - Tpetra_CrsGraph_Sl_LO_Sc_GO_Sc_NO_Sg__getgblRowView((Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const *)arg1,arg2,arg3); + Tpetra_CrsGraph_Sl_LO_Sc_GO_Sc_NO_Sg__getGlobalRowView((Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const *)arg1,arg2,arg3); } catch (const std::range_error& e) { // Store a C++ exception - SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::getgblRowView(GO const,std::pair< GO const *,std::size_t >) const", SWIG_IndexError, e.what(), return ); + SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::getGlobalRowView(GO const,std::pair< GO const *,std::size_t >) const", SWIG_IndexError, e.what(), return ); } catch (const std::exception& e) { // Store a C++ exception - SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::getgblRowView(GO const,std::pair< GO const *,std::size_t >) const", SWIG_RuntimeError, e.what(), return ); + SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::getGlobalRowView(GO const,std::pair< GO const *,std::size_t >) const", SWIG_RuntimeError, e.what(), return ); } catch (...) { - SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::getgblRowView(GO const,std::pair< GO const *,std::size_t >) const", SWIG_UnknownError, "An unknown exception occurred", return ); + SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::getGlobalRowView(GO const,std::pair< GO const *,std::size_t >) const", SWIG_UnknownError, "An unknown exception occurred", return ); } } diff --git a/src/tpetra/tutorials/MapsAndVectors.F90 b/src/tpetra/tutorials/MapsAndVectors.F90 index ef019a7e..c1d0bea5 100644 --- a/src/tpetra/tutorials/MapsAndVectors.F90 +++ b/src/tpetra/tutorials/MapsAndVectors.F90 @@ -138,7 +138,7 @@ program main do k = 1, num_elements_per_proc element_list(k) = int(my_rank + k * num_procs, kind=global_ordinal_type) end do -cyclic_map = TpetraMap(num_global_entries, element_list, comm); +cyclic_map = TpetraMap(num_global_entries, element_list, comm) deallocate(element_list) ! If there's more than one MPI process in the communicator, then cyclic_map is From 9cb71497e957fd6e59ad1c5b751527f70407d22b Mon Sep 17 00:00:00 2001 From: Seth R Johnson Date: Fri, 1 Feb 2019 21:08:11 -0500 Subject: [PATCH 08/40] Clean warnings in unit tests --- src/interface/test/Tpetra_ModelEvaluator_1DFEM.F90 | 2 -- src/interface/test/test_eigen_handle.F90 | 3 +-- src/interface/test/test_futility_reproducer.F90 | 6 +----- src/interface/test/test_solver_handle.F90 | 1 - src/tpetra/test/test_tpetra_crsmatrix.F90 | 14 +++++++------- 5 files changed, 9 insertions(+), 17 deletions(-) diff --git a/src/interface/test/Tpetra_ModelEvaluator_1DFEM.F90 b/src/interface/test/Tpetra_ModelEvaluator_1DFEM.F90 index adc8def0..d443b2e0 100644 --- a/src/interface/test/Tpetra_ModelEvaluator_1DFEM.F90 +++ b/src/interface/test/Tpetra_ModelEvaluator_1DFEM.F90 @@ -455,8 +455,6 @@ subroutine TpetraModelEvaluator1DFEM_eval_prec(self, x, M) integer(size_type), parameter :: ione=1 real(scalar_type), dimension(:), pointer :: xdata real(scalar_type), dimension(:), pointer :: udata - type(TpetraMultiVector) :: diag - integer(size_type) :: num_vecs=1 integer :: my_rank real(scalar_type) :: xx(2), uu(2), vals(1) ! ------------------------------------------------------------------------ ! diff --git a/src/interface/test/test_eigen_handle.F90 b/src/interface/test/test_eigen_handle.F90 index eb53fb7b..4a606080 100644 --- a/src/interface/test/test_eigen_handle.F90 +++ b/src/interface/test/test_eigen_handle.F90 @@ -25,7 +25,7 @@ program main integer(int_type) :: my_rank, num_procs integer(global_size_type) :: n_global - integer(size_type) :: n, max_entries_per_row, lda + integer(size_type) :: n, max_entries_per_row integer(size_type) :: num_eigen = 1, num_found_eigen integer(int_type) :: num_eigen_int integer(int_type) :: row_nnz @@ -33,7 +33,6 @@ program main integer :: ierr integer(local_ordinal_type) :: i integer(global_ordinal_type) :: offset - real(scalar_type) :: one = 1.0 type(TeuchosComm) :: comm type(ParameterList) :: plist diff --git a/src/interface/test/test_futility_reproducer.F90 b/src/interface/test/test_futility_reproducer.F90 index 5f84b68b..69fc136d 100644 --- a/src/interface/test/test_futility_reproducer.F90 +++ b/src/interface/test/test_futility_reproducer.F90 @@ -26,15 +26,11 @@ program main integer(int_type) :: my_rank, num_procs integer(global_size_type) :: n_global - integer(size_type) :: n, max_entries_per_row, lda + integer(size_type) :: n, max_entries_per_row integer(size_type) :: num_eigen = 1, num_found_eigen integer(int_type) :: num_eigen_int - integer(int_type) :: row_nnz integer :: ierr - integer(local_ordinal_type) :: i - integer(global_ordinal_type) :: offset - real(scalar_type) :: one = 1.0 type(TeuchosComm) :: comm type(ParameterList) :: plist diff --git a/src/interface/test/test_solver_handle.F90 b/src/interface/test/test_solver_handle.F90 index 46b33313..f451ad3c 100644 --- a/src/interface/test/test_solver_handle.F90 +++ b/src/interface/test/test_solver_handle.F90 @@ -177,7 +177,6 @@ program main integer(local_ordinal_type) :: i integer(global_ordinal_type) :: offset real(scalar_type) :: one = 1.0 - real(norm_type) :: norm type(TeuchosComm) :: comm type(ParameterList) :: plist, linear_solver_list, belos_list, solver_list, krylov_list diff --git a/src/tpetra/test/test_tpetra_crsmatrix.F90 b/src/tpetra/test/test_tpetra_crsmatrix.F90 index 74591348..8d1331c1 100644 --- a/src/tpetra/test/test_tpetra_crsmatrix.F90 +++ b/src/tpetra/test/test_tpetra_crsmatrix.F90 @@ -187,7 +187,7 @@ program test_TpetraCrsMatrix type(TpetraMap) :: Map, row_map type(TpetraCrsMatrix) :: A type(TpetraMultiVector) :: ones, threes - integer(size_type), parameter :: izero=0, ione=1, ithree=3 + integer(size_type), parameter :: izero=0, ione=1 integer(size_type) :: num_images, my_image_id, numindices integer(local_ordinal_type) :: nnz real(scalar_type), parameter :: zero=0., one=1., two=2., negthree=-3. @@ -298,7 +298,7 @@ program test_TpetraCrsMatrix type(TpetraMap) :: Map type(TpetraCrsMatrix) :: Mat type(TpetraMultiVector) :: X, Y, Z - integer(size_type), parameter :: ione=1, ithree=3, numvecs=1 + integer(size_type), parameter :: numvecs=1 real(scalar_type), parameter :: zero=0., one=1. real(scalar_type) :: alpha, beta integer(size_type) :: my_image_id @@ -310,11 +310,11 @@ program test_TpetraCrsMatrix my_image_id = comm%getRank() ! create a Map - map = TpetraMap(TPETRA_GLOBAL_INVALID, ithree, comm); TEST_IERR() + map = TpetraMap(TPETRA_GLOBAL_INVALID, 3_size_type, comm); TEST_IERR() ! Create the identity matrix, three rows per proc base = 3 * my_image_id; - Mat = TpetraCrsMatrix(Map, ione, TpetraDynamicProfile); TEST_IERR() + Mat = TpetraCrsMatrix(Map, 1_size_type, TpetraDynamicProfile); TEST_IERR() do i = 1, 3 gblrow = base + i cols(1) = gblrow @@ -498,8 +498,8 @@ program test_TpetraCrsMatrix row = 1; cols(1) = 1; vals(1) = zero; call Mat%insertLocalValues(row, cols, vals); TEST_IERR() - params = ParameterList("ANONOMOUS"); TEST_IERR() - !call params%set("Optimize Storage", .false.); TEST_IERR() ! FIXME: boolean parameters + params = ParameterList("ANONYMOUS"); TEST_IERR() + call params%set("Optimize Storage", .false.); TEST_IERR() call Mat%fillComplete(params); TEST_IERR() TEST_ASSERT((.not. Mat%isFillActive())) TEST_ASSERT(Mat%isFillComplete()) @@ -527,7 +527,6 @@ program test_TpetraCrsMatrix OUT0("Finished TpetraCrsMatrix_ActiveFillLocal!") END_FORTRILINOS_UNIT_TEST(TpetraCrsMatrix_ActiveFillLocal) -#endif ! -------------------------------getCrsGraph-------------------------------- ! FORTRILINOS_UNIT_TEST(TpetraCrsMatrix_getCrsGraph) @@ -862,6 +861,7 @@ program test_TpetraCrsMatrix OUT0("Finished TpetraCrsMatrix_removeEmptyProcessesInPlace") END_FORTRILINOS_UNIT_TEST(TpetraCrsMatrix_removeEmptyProcessesInPlace) +#endif end program test_TpetraCrsMatrix From d91a10d4e46d65e2aefd0a90715442aec6d8e516 Mon Sep 17 00:00:00 2001 From: Seth R Johnson Date: Sat, 2 Feb 2019 08:17:31 -0500 Subject: [PATCH 09/40] Replace local_ordinal_type with native Fortran int Also simplify literal types in the test code: this cleans up a number of warnings about conversions, including an unintentional conversion to single-precision reals (the literal 3.0 was used). Also commented out unused functions that were generating warnings. --- .../test/Tpetra_ModelEvaluator_1DFEM.F90 | 24 +- src/interface/test/test_eigen_handle.F90 | 6 +- .../test/test_futility_reproducer.F90 | 13 +- src/interface/test/test_solver_handle.F90 | 23 +- src/teuchos/src/forteuchos.i | 6 + src/teuchos/src/swig/forteuchos.F90 | 12 +- src/tpetra/src/Tpetra_CrsGraph.i | 3 + src/tpetra/src/Tpetra_CrsMatrix.i | 3 +- src/tpetra/src/Tpetra_InOut.i | 3 + src/tpetra/src/Tpetra_Map.i | 6 +- src/tpetra/src/Tpetra_MultiVector.i | 5 + src/tpetra/src/fortpetra.i | 2 - src/tpetra/src/swig/fortpetra.F90 | 354 +++++++++--------- src/tpetra/src/swig/fortpetraFORTRAN_wrap.cxx | 289 +++++++------- src/tpetra/test/test_tpetra_crsgraph.F90 | 98 +++-- src/tpetra/test/test_tpetra_crsmatrix.F90 | 127 +++---- src/tpetra/test/test_tpetra_import_export.F90 | 22 +- src/tpetra/test/test_tpetra_map.F90 | 20 +- src/tpetra/test/test_tpetra_multivector.F90 | 137 +++---- src/tpetra/tutorials/MapsAndVectors.F90 | 4 +- src/tpetra/tutorials/PowerMethod.F90 | 15 +- 21 files changed, 593 insertions(+), 579 deletions(-) diff --git a/src/interface/test/Tpetra_ModelEvaluator_1DFEM.F90 b/src/interface/test/Tpetra_ModelEvaluator_1DFEM.F90 index d443b2e0..66985041 100644 --- a/src/interface/test/Tpetra_ModelEvaluator_1DFEM.F90 +++ b/src/interface/test/Tpetra_ModelEvaluator_1DFEM.F90 @@ -86,11 +86,11 @@ subroutine compute_basis(self, gp, z, u, uold) ! Calculates the values of z and u at the specified Gauss point ! ------------------------------------------------------------------------ ! class(Linear2NodeFEBasis) :: self - integer(local_ordinal_type), intent(in) :: gp + integer, intent(in) :: gp real(scalar_type), intent(in) :: z(2), u(2) real(scalar_type), intent(in), optional :: uold(2) real(scalar_type) :: eta - integer(local_ordinal_type) :: i + integer :: i if (gp==1) then eta = -1.0 / sqrt(3.0) @@ -202,9 +202,9 @@ function create_graph(self, owned_map, ghosted_map) result(graph) class(TpetraModelEvaluator1DFEM) :: self type(TpetraCrsGraph) :: graph type(TpetraMap) :: owned_map, ghosted_map - integer(local_ordinal_type) :: ne, i, j + integer :: ne, num_my_overlap_nodes, i, j integer(global_ordinal_type) :: gblrow, gblinds(1) - integer(size_type) :: num_my_overlap_nodes, num_ent_per_row + integer(size_type) :: num_ent_per_row ! ------------------------------------------------------------------------ ! ! Create the shell for the graph @@ -248,8 +248,8 @@ function create_mesh(self, owned_map, z_min, z_max, num_elems) result(coords) type(TpetraMap), intent(in) :: owned_map real(scalar_type), intent(in) :: z_min, z_max integer(global_size_type), intent(in) :: num_elems - integer(local_ordinal_type) :: lclrow - integer(size_type) :: num_local_nodes, num_vecs=1 + integer(size_type) :: num_vecs=1 + integer :: lclrow, num_local_nodes integer(global_ordinal_type) :: min_GID, col=1 real(scalar_type) :: dz ! ------------------------------------------------------------------------ ! @@ -257,7 +257,7 @@ function create_mesh(self, owned_map, z_min, z_max, num_elems) result(coords) num_local_nodes = owned_map%getNodeNumElements() min_GID = owned_map%getMinGlobalIndex() dz = (z_max - z_min) / num_elems - coords = TpetraMultiVector(owned_map, num_vecs); + coords = TpetraMultiVector(owned_map, num_vecs) do lclrow=1, num_local_nodes call coords%replaceLocalValue(lclrow, col, z_min + dz * (min_GID+lclrow)) end do @@ -285,7 +285,7 @@ subroutine TpetraModelEvaluator1DFEM_eval_resid(self, x, f) class(TpetraMultiVector), intent(in) :: x class(TpetraMultiVector), intent(inout) :: f type(Linear2NodeFEBasis) :: basis - integer(local_ordinal_type) :: ne, num_my_elems, gp, i, lclrow + integer :: num_my_elems, ne, gp, i, lclrow integer(size_type) :: col integer :: my_rank integer(size_type), parameter :: ione=1 @@ -358,8 +358,8 @@ subroutine TpetraModelEvaluator1DFEM_eval_jac(self, x, J) class(TpetraOperator), intent(inout) :: J type(TpetraCrsMatrix) :: Jmat type(Linear2NodeFEBasis) :: basis - integer(local_ordinal_type) :: ne, num_my_elems, gp, i, jj - integer(local_ordinal_type) :: lclrow, lclcol, numvalid + integer :: ne, num_my_elems, gp, i, jj + integer :: lclrow, lclcol, numvalid integer(global_ordinal_type) :: gblrow, cols(1) real(scalar_type), dimension(:), pointer :: xdata real(scalar_type), dimension(:), pointer :: udata @@ -449,8 +449,8 @@ subroutine TpetraModelEvaluator1DFEM_eval_prec(self, x, M) type(TpetraCrsMatrix) :: Mmat type(TpetraMap) :: row_map, col_map type(Linear2NodeFEBasis) :: basis - integer(local_ordinal_type) :: ne, num_my_elems, gp, i, j - integer(local_ordinal_type) :: lclrow, lclcol, numvalid + integer :: ne, num_my_elems, gp, i, j + integer :: lclrow, lclcol, numvalid integer(global_ordinal_type) :: gblrow, cols(1) integer(size_type), parameter :: ione=1 real(scalar_type), dimension(:), pointer :: xdata diff --git a/src/interface/test/test_eigen_handle.F90 b/src/interface/test/test_eigen_handle.F90 index 4a606080..24e5eb42 100644 --- a/src/interface/test/test_eigen_handle.F90 +++ b/src/interface/test/test_eigen_handle.F90 @@ -22,16 +22,16 @@ program main implicit none - integer(int_type) :: my_rank, num_procs + integer :: my_rank, num_procs integer(global_size_type) :: n_global - integer(size_type) :: n, max_entries_per_row + integer:: i, n + integer(size_type) :: max_entries_per_row integer(size_type) :: num_eigen = 1, num_found_eigen integer(int_type) :: num_eigen_int integer(int_type) :: row_nnz integer :: ierr - integer(local_ordinal_type) :: i integer(global_ordinal_type) :: offset type(TeuchosComm) :: comm diff --git a/src/interface/test/test_futility_reproducer.F90 b/src/interface/test/test_futility_reproducer.F90 index 69fc136d..08fb0733 100644 --- a/src/interface/test/test_futility_reproducer.F90 +++ b/src/interface/test/test_futility_reproducer.F90 @@ -26,9 +26,9 @@ program main integer(int_type) :: my_rank, num_procs integer(global_size_type) :: n_global - integer(size_type) :: n, max_entries_per_row + integer(size_type) :: max_entries_per_row + integer :: n integer(size_type) :: num_eigen = 1, num_found_eigen - integer(int_type) :: num_eigen_int integer :: ierr @@ -69,8 +69,7 @@ program main call load_from_xml(plist, "davidson.xml"); FORTRILINOS_CHECK_IERR() call plist%set("Preconditioner Type", "IDENTITY") - num_eigen_int = num_eigen - call plist%set("NumEV", num_eigen_int); FORTRILINOS_CHECK_IERR() + call plist%set("NumEV", 1); FORTRILINOS_CHECK_IERR() ! ------------------------------------------------------------------ ! Step 0: Construct A and B matrices @@ -83,17 +82,17 @@ program main cols(2) = 2 vals(1) = 0.0015 vals(2) = 0.325 - call A%insertGlobalValues(INT(1,global_ordinal_type), cols(1:2), vals(1:2)); FORTRILINOS_CHECK_IERR() + call A%insertGlobalValues(1_global_ordinal_type, cols(1:2), vals(1:2)); FORTRILINOS_CHECK_IERR() B = TpetraCrsMatrix(map, map, max_entries_per_row) cols(1) = 1 vals(1) = 0.1208 - call B%insertGlobalValues(INT(1,global_ordinal_type), cols(1:1), vals(1:1)); FORTRILINOS_CHECK_IERR() + call B%insertGlobalValues(1_global_ordinal_type, cols(1:1), vals(1:1)); FORTRILINOS_CHECK_IERR() cols(1) = 1 cols(2) = 2 vals(1) = -0.117 vals(2) = 0.184 - call B%insertGlobalValues(INT(2,global_ordinal_type), cols(1:2), vals(1:2)); FORTRILINOS_CHECK_IERR() + call B%insertGlobalValues(2_global_ordinal_type, cols(1:2), vals(1:2)); FORTRILINOS_CHECK_IERR() call A%fillComplete(); FORTRILINOS_CHECK_IERR() call B%fillComplete(); FORTRILINOS_CHECK_IERR() diff --git a/src/interface/test/test_solver_handle.F90 b/src/interface/test/test_solver_handle.F90 index f451ad3c..052f4f96 100644 --- a/src/interface/test/test_solver_handle.F90 +++ b/src/interface/test/test_solver_handle.F90 @@ -41,14 +41,14 @@ subroutine my_apply(self, x, y, mode, alpha, beta) integer(kind(TeuchosETransp)), intent(in) :: mode real(scalar_type), intent(in) :: alpha real(scalar_type), intent(in) :: beta - integer(local_ordinal_type) :: i, lid + integer :: lid integer(global_ordinal_type) :: gid type(TeuchosComm) :: comm type(TpetraImport) :: import type(TpetraMultiVector) :: x_ghosted - integer(int_type) :: my_rank, num_procs - integer(size_type) :: n + integer :: my_rank, num_procs + integer :: i, n real(scalar_type), dimension(:), pointer :: xdata real(scalar_type), dimension(:), pointer :: ydata @@ -61,12 +61,12 @@ subroutine my_apply(self, x, y, mode, alpha, beta) num_procs = comm%getSize() import = TpetraImport(self%domain_map, self%col_map) - x_ghosted = TpetraMultiVector(self%col_map, INT(1,size_type)) + x_ghosted = TpetraMultiVector(self%col_map, 1_size_type) call x_ghosted%doImport(x, import, TpetraINSERT) call import%release() - xdata => x_ghosted%getData (INT(1,size_type)) - ydata => y %getDataNonConst(INT(1,size_type)) + xdata => x_ghosted%getData (1_size_type) + ydata => y %getDataNonConst(1_size_type) n = y%getLocalLength() ! Sometimes, ydata may be unitialized (when beta is 0), potentially containing @@ -167,16 +167,15 @@ program main use myoperators implicit none - integer(int_type) :: my_rank, num_procs + integer :: my_rank, num_procs integer(global_size_type) :: n_global - integer(size_type) :: n, max_entries_per_row, num_vecs = 1, lda + integer(size_type) :: max_entries_per_row, num_vecs = 1, lda integer(int_type) :: row_nnz integer :: ierr - integer(local_ordinal_type) :: i + integer :: i, n integer(global_ordinal_type) :: offset - real(scalar_type) :: one = 1.0 type(TeuchosComm) :: comm type(ParameterList) :: plist, linear_solver_list, belos_list, solver_list, krylov_list @@ -294,7 +293,7 @@ program main call solver_handle%solve(B, X); FORTRILINOS_CHECK_IERR() ! Check the solution - call X%update(-one, Xtrue, one); FORTRILINOS_CHECK_IERR() + call X%update(-1.d0, Xtrue, 1.d0); FORTRILINOS_CHECK_IERR() call X%norm2(norms); FORTRILINOS_CHECK_IERR() ! TODO: Get the tolerance out of the parameter list @@ -339,7 +338,7 @@ program main call X%randomize() call solver_handle%solve(B, X); FORTRILINOS_CHECK_IERR() - call X%update(-one, Xtrue, one); FORTRILINOS_CHECK_IERR() + call X%update(-1.d0, Xtrue, 1.d0); FORTRILINOS_CHECK_IERR() call X%norm2(norms); FORTRILINOS_CHECK_IERR() if (norms(1) > 1e-10) then write(error_unit, '(A)') 'The implicit result differs from explicit!' diff --git a/src/teuchos/src/forteuchos.i b/src/teuchos/src/forteuchos.i index f84f7699..d48e024b 100644 --- a/src/teuchos/src/forteuchos.i +++ b/src/teuchos/src/forteuchos.i @@ -14,6 +14,12 @@ // Typedefs typedef int Teuchos_Ordinal; +// Treat plain 'int' (and Teuchos_Ordinal) as native integers. +// Assume that large integers are defined as size_t or global_ordinal +%typemap(ftype, in="integer, intent(in)") int "integer" +%typemap(fin) int "$1 = int($input, C_INT)" +%typemap(fout) int "$result = int($1)" + // pair typemaps: (TODO: these should be deprecated) %include %fortran_view(int) diff --git a/src/teuchos/src/swig/forteuchos.F90 b/src/teuchos/src/swig/forteuchos.F90 index 7b2a48a2..82f3e4a4 100644 --- a/src/teuchos/src/swig/forteuchos.F90 +++ b/src/teuchos/src/swig/forteuchos.F90 @@ -767,7 +767,7 @@ subroutine swigf_assignment_TeuchosArrayLongLong(self, other) function swigf_TeuchosComm_getRank(self) & result(swig_result) use, intrinsic :: ISO_C_BINDING -integer(C_INT) :: swig_result +integer :: swig_result class(TeuchosComm), intent(in) :: self integer(C_INT) :: fresult @@ -775,13 +775,13 @@ function swigf_TeuchosComm_getRank(self) & farg1 = self%swigdata fresult = swigc_TeuchosComm_getRank(farg1) -swig_result = fresult +swig_result = int(fresult) end function function swigf_TeuchosComm_getSize(self) & result(swig_result) use, intrinsic :: ISO_C_BINDING -integer(C_INT) :: swig_result +integer :: swig_result class(TeuchosComm), intent(in) :: self integer(C_INT) :: fresult @@ -789,7 +789,7 @@ function swigf_TeuchosComm_getSize(self) & farg1 = self%swigdata fresult = swigc_TeuchosComm_getSize(farg1) -swig_result = fresult +swig_result = int(fresult) end function subroutine swigf_TeuchosComm_barrier(self) @@ -1005,7 +1005,7 @@ subroutine swigf_ParameterList_set__SWIG_2(self, name, value) character(kind=C_CHAR, len=*), target :: name character(kind=C_CHAR), dimension(:), allocatable, target :: farg2_chars -integer(C_INT), intent(in) :: value +integer, intent(in) :: value type(SwigClassWrapper) :: farg1 type(SwigArrayWrapper) :: farg2 @@ -1188,7 +1188,7 @@ function swigf_ParameterList_get_real(self, name) & function swigf_ParameterList_get_integer(self, name) & result(swig_result) use, intrinsic :: ISO_C_BINDING -integer(C_INT) :: swig_result +integer :: swig_result class(ParameterList), intent(inout) :: self character(kind=C_CHAR, len=*), target :: name diff --git a/src/tpetra/src/Tpetra_CrsGraph.i b/src/tpetra/src/Tpetra_CrsGraph.i index 275df2ac..606ddcd9 100644 --- a/src/tpetra/src/Tpetra_CrsGraph.i +++ b/src/tpetra/src/Tpetra_CrsGraph.i @@ -85,6 +85,9 @@ $1 = &tmpview; } +%apply int { size_t getNumEntriesInLocalRow, + size_t getNumAllocatedEntriesInLocalRow} + // ======================================================================= // Make interface more Fortran friendly // ======================================================================= diff --git a/src/tpetra/src/Tpetra_CrsMatrix.i b/src/tpetra/src/Tpetra_CrsMatrix.i index 21f81838..9b79c55e 100644 --- a/src/tpetra/src/Tpetra_CrsMatrix.i +++ b/src/tpetra/src/Tpetra_CrsMatrix.i @@ -79,7 +79,8 @@ // ======================================================================= // Fix ±1 issues // ======================================================================= -%typemap(in) int localRow %{$1 = *$input - 1;%} // int = LO +%apply int INDEX { int localRow }; + %ignore Tpetra::CrsMatrix::getLocalRowView; // ±1 issue %ignore Tpetra::CrsMatrix::reorderedLocalGaussSeidel; // ±1 issue %ignore Tpetra::CrsMatrix::replaceLocalValues; // ±1 issue diff --git a/src/tpetra/src/Tpetra_InOut.i b/src/tpetra/src/Tpetra_InOut.i index 07f58713..da9c1fd3 100644 --- a/src/tpetra/src/Tpetra_InOut.i +++ b/src/tpetra/src/Tpetra_InOut.i @@ -14,6 +14,9 @@ #include "MatrixMarket_Tpetra.hpp" %} +// Function signatures for local quantities are incorrectly declared as size_t +%apply LO { size_t getNumEntriesInLocalRow }; + // ======================================================================= // Ignore permanently // ======================================================================= diff --git a/src/tpetra/src/Tpetra_Map.i b/src/tpetra/src/Tpetra_Map.i index 390124f5..c1c5fe1d 100644 --- a/src/tpetra/src/Tpetra_Map.i +++ b/src/tpetra/src/Tpetra_Map.i @@ -17,7 +17,7 @@ %insert("fdecl") %{ integer(global_ordinal_type), parameter, public :: TPETRA_GLOBAL_INVALID = -1 - integer(local_ordinal_type), parameter, public :: TPETRA_LOCAL_INVALID = 0 + integer, parameter, public :: TPETRA_LOCAL_INVALID = 0 %} // ======================================================================= @@ -39,6 +39,10 @@ %ignore Tpetra::Map::getLocalMap; // no need to expose this yet %ignore Tpetra::Map::getMyGlobalIndices; // return type is not exposed externally, requires using `auto`; for now, use getNodeElementList +// Function signatures for local quantities are incorrectly declared as size_t +%apply LO { size_t getNodeNumElements, + size_t numLocalElements }; + // ======================================================================= // Fix ±1 issues // ======================================================================= diff --git a/src/tpetra/src/Tpetra_MultiVector.i b/src/tpetra/src/Tpetra_MultiVector.i index 2c1ef700..3e3796d4 100644 --- a/src/tpetra/src/Tpetra_MultiVector.i +++ b/src/tpetra/src/Tpetra_MultiVector.i @@ -18,6 +18,11 @@ %apply Teuchos::ArrayView { Teuchos::ArrayRCP }; %apply Teuchos::ArrayView { Teuchos::ArrayRCP }; +// Function signatures for local quantities are incorrectly declared as size_t +%apply LO { size_t getLocalLength, + size_t getOrigNumLocalRows, + size_t getOrigNumLocalCols }; + // ======================================================================= // Postpone temporarily // ======================================================================= diff --git a/src/tpetra/src/fortpetra.i b/src/tpetra/src/fortpetra.i index 12535573..c58bfa4e 100644 --- a/src/tpetra/src/fortpetra.i +++ b/src/tpetra/src/fortpetra.i @@ -42,7 +42,6 @@ typedef char Packet; c_size_t, & c_double, & scalar_type => c_double, & - local_ordinal_type => c_int, & global_ordinal_type => c_long_long, & global_size_type => c_long, & size_type => c_size_t, & @@ -52,7 +51,6 @@ typedef char Packet; } %insert("fdecl") { public :: scalar_type -public :: local_ordinal_type public :: global_ordinal_type public :: global_size_type public :: size_type diff --git a/src/tpetra/src/swig/fortpetra.F90 b/src/tpetra/src/swig/fortpetra.F90 index 399f0cde..b5323af8 100644 --- a/src/tpetra/src/swig/fortpetra.F90 +++ b/src/tpetra/src/swig/fortpetra.F90 @@ -22,7 +22,6 @@ module fortpetra c_size_t, & c_double, & scalar_type => c_double, & - local_ordinal_type => c_int, & global_ordinal_type => c_long_long, & global_size_type => c_long, & size_type => c_size_t, & @@ -36,7 +35,6 @@ module fortpetra ! DECLARATION CONSTRUCTS public :: scalar_type -public :: local_ordinal_type public :: global_ordinal_type public :: global_size_type public :: size_type @@ -120,7 +118,7 @@ module fortpetra public :: combineModeToString integer(global_ordinal_type), parameter, public :: TPETRA_GLOBAL_INVALID = -1 - integer(local_ordinal_type), parameter, public :: TPETRA_LOCAL_INVALID = 0 + integer, parameter, public :: TPETRA_LOCAL_INVALID = 0 ! class Tpetra::Map< LO,GO,NO > type, public :: TpetraMap @@ -216,11 +214,9 @@ module fortpetra module procedure new_TpetraImport__SWIG_2 module procedure new_TpetraImport__SWIG_3 end interface -integer, parameter, public :: SWIGTYPE_Teuchos__DataAccess = C_INT type, public :: SWIGTYPE_Kokkos__ViewT_double_p_Kokkos__HostSpace_t type(SwigClassWrapper), public :: swigdata end type -integer, parameter, public :: SWIGTYPE_Teuchos__ETransp = C_INT ! class Tpetra::MultiVector< SC,LO,GO,NO > type, public :: TpetraMultiVector type(SwigClassWrapper), public :: swigdata @@ -238,9 +234,6 @@ module fortpetra procedure, private :: randomize__SWIG_1 => swigf_TpetraMultiVector_randomize__SWIG_1 procedure :: replaceMap => swigf_TpetraMultiVector_replaceMap procedure :: reduce => swigf_TpetraMultiVector_reduce - procedure :: subCopy => swigf_TpetraMultiVector_subCopy - procedure :: subView => swigf_TpetraMultiVector_subView - procedure :: subViewNonConst => swigf_TpetraMultiVector_subViewNonConst procedure :: offsetView => swigf_TpetraMultiVector_offsetView procedure :: offsetViewNonConst => swigf_TpetraMultiVector_offsetViewNonConst procedure :: getData => swigf_TpetraMultiVector_getData @@ -281,6 +274,9 @@ module fortpetra procedure :: setCopyOrView => swigf_TpetraMultiVector_setCopyOrView procedure :: getCopyOrView => swigf_TpetraMultiVector_getCopyOrView procedure :: isSameSize => swigf_TpetraMultiVector_isSameSize + procedure :: subCopy => swigf_TpetraMultiVector_subCopy + procedure :: subView => swigf_TpetraMultiVector_subView + procedure :: subViewNonConst => swigf_TpetraMultiVector_subViewNonConst procedure, private :: doImport__SWIG_0 => swigf_TpetraMultiVector_doImport__SWIG_0 procedure, private :: doImport__SWIG_1 => swigf_TpetraMultiVector_doImport__SWIG_1 procedure, private :: doExport__SWIG_0 => swigf_TpetraMultiVector_doExport__SWIG_0 @@ -764,7 +760,7 @@ function swigc_TpetraMap_getNodeNumElements(farg1) & use, intrinsic :: ISO_C_BINDING import :: swigclasswrapper type(SwigClassWrapper) :: farg1 -integer(C_SIZE_T) :: fresult +integer(C_INT) :: fresult end function function swigc_TpetraMap_getMinLocalIndex(farg1) & @@ -993,7 +989,7 @@ function swigc_new_TpetraMap__SWIG_3(farg1, farg2, farg3) & use, intrinsic :: ISO_C_BINDING import :: swigclasswrapper integer(C_LONG), intent(in) :: farg1 -integer(C_SIZE_T), intent(in) :: farg2 +integer(C_INT), intent(in) :: farg2 type(SwigClassWrapper) :: farg3 type(SwigClassWrapper) :: fresult end function @@ -1527,39 +1523,6 @@ subroutine swigc_TpetraMultiVector_reduce(farg1) & type(SwigClassWrapper) :: farg1 end subroutine -function swigc_TpetraMultiVector_subCopy(farg1, farg2) & -bind(C, name="_wrap_TpetraMultiVector_subCopy") & -result(fresult) -use, intrinsic :: ISO_C_BINDING -import :: swigclasswrapper -import :: swigarraywrapper -type(SwigClassWrapper) :: farg1 -type(SwigArrayWrapper) :: farg2 -type(SwigClassWrapper) :: fresult -end function - -function swigc_TpetraMultiVector_subView(farg1, farg2) & -bind(C, name="_wrap_TpetraMultiVector_subView") & -result(fresult) -use, intrinsic :: ISO_C_BINDING -import :: swigclasswrapper -import :: swigarraywrapper -type(SwigClassWrapper) :: farg1 -type(SwigArrayWrapper) :: farg2 -type(SwigClassWrapper) :: fresult -end function - -function swigc_TpetraMultiVector_subViewNonConst(farg1, farg2) & -bind(C, name="_wrap_TpetraMultiVector_subViewNonConst") & -result(fresult) -use, intrinsic :: ISO_C_BINDING -import :: swigclasswrapper -import :: swigarraywrapper -type(SwigClassWrapper) :: farg1 -type(SwigArrayWrapper) :: farg2 -type(SwigClassWrapper) :: fresult -end function - function swigc_TpetraMultiVector_offsetView(farg1, farg2, farg3) & bind(C, name="_wrap_TpetraMultiVector_offsetView") & result(fresult) @@ -1851,7 +1814,7 @@ function swigc_TpetraMultiVector_getLocalLength(farg1) & use, intrinsic :: ISO_C_BINDING import :: swigclasswrapper type(SwigClassWrapper) :: farg1 -integer(C_SIZE_T) :: fresult +integer(C_INT) :: fresult end function function swigc_TpetraMultiVector_getGlobalLength(farg1) & @@ -1926,6 +1889,39 @@ function swigc_TpetraMultiVector_isSameSize(farg1, farg2) & integer(C_INT) :: fresult end function +function swigc_TpetraMultiVector_subCopy(farg1, farg2) & +bind(C, name="_wrap_TpetraMultiVector_subCopy") & +result(fresult) +use, intrinsic :: ISO_C_BINDING +import :: swigclasswrapper +import :: swigarraywrapper +type(SwigClassWrapper) :: farg1 +type(SwigArrayWrapper) :: farg2 +type(SwigClassWrapper) :: fresult +end function + +function swigc_TpetraMultiVector_subView(farg1, farg2) & +bind(C, name="_wrap_TpetraMultiVector_subView") & +result(fresult) +use, intrinsic :: ISO_C_BINDING +import :: swigclasswrapper +import :: swigarraywrapper +type(SwigClassWrapper) :: farg1 +type(SwigArrayWrapper) :: farg2 +type(SwigClassWrapper) :: fresult +end function + +function swigc_TpetraMultiVector_subViewNonConst(farg1, farg2) & +bind(C, name="_wrap_TpetraMultiVector_subViewNonConst") & +result(fresult) +use, intrinsic :: ISO_C_BINDING +import :: swigclasswrapper +import :: swigarraywrapper +type(SwigClassWrapper) :: farg1 +type(SwigArrayWrapper) :: farg2 +type(SwigClassWrapper) :: fresult +end function + subroutine swigc_TpetraMultiVector_doImport__SWIG_0(farg1, farg2, farg3, farg4) & bind(C, name="_wrap_TpetraMultiVector_doImport__SWIG_0") use, intrinsic :: ISO_C_BINDING @@ -2507,7 +2503,7 @@ function swigc_TpetraCrsGraph_getNumEntriesInLocalRow(farg1, farg2) & import :: swigclasswrapper type(SwigClassWrapper) :: farg1 integer(C_INT), intent(in) :: farg2 -integer(C_SIZE_T) :: fresult +integer(C_INT) :: fresult end function function swigc_TpetraCrsGraph_getNodeAllocationSize(farg1) & @@ -2536,7 +2532,7 @@ function swigc_TpetraCrsGraph_getNumAllocatedEntriesInLocalRow(farg1, farg2) & import :: swigclasswrapper type(SwigClassWrapper) :: farg1 integer(C_INT), intent(in) :: farg2 -integer(C_SIZE_T) :: fresult +integer(C_INT) :: fresult end function function swigc_TpetraCrsGraph_getGlobalNumDiags(farg1) & @@ -3511,7 +3507,7 @@ function swigc_TpetraCrsMatrix_getNumEntriesInLocalRow(farg1, farg2) & import :: swigclasswrapper type(SwigClassWrapper) :: farg1 integer(C_INT), intent(in) :: farg2 -integer(C_SIZE_T) :: fresult +integer(C_INT) :: fresult end function function swigc_TpetraCrsMatrix_getGlobalNumDiagsImpl(farg1) & @@ -4942,21 +4938,21 @@ function swigf_TpetraMap_getGlobalNumElements(self) & function swigf_TpetraMap_getNodeNumElements(self) & result(swig_result) use, intrinsic :: ISO_C_BINDING -integer(C_SIZE_T) :: swig_result +integer :: swig_result class(TpetraMap), intent(in) :: self -integer(C_SIZE_T) :: fresult +integer(C_INT) :: fresult type(SwigClassWrapper) :: farg1 farg1 = self%swigdata fresult = swigc_TpetraMap_getNodeNumElements(farg1) -swig_result = fresult +swig_result = int(fresult) end function function swigf_TpetraMap_getMinLocalIndex(self) & result(swig_result) use, intrinsic :: ISO_C_BINDING -integer(C_INT) :: swig_result +integer :: swig_result class(TpetraMap), intent(in) :: self integer(C_INT) :: fresult @@ -4964,13 +4960,13 @@ function swigf_TpetraMap_getMinLocalIndex(self) & farg1 = self%swigdata fresult = swigc_TpetraMap_getMinLocalIndex(farg1) -swig_result = fresult +swig_result = int(fresult) end function function swigf_TpetraMap_getMaxLocalIndex(self) & result(swig_result) use, intrinsic :: ISO_C_BINDING -integer(C_INT) :: swig_result +integer :: swig_result class(TpetraMap), intent(in) :: self integer(C_INT) :: fresult @@ -4978,7 +4974,7 @@ function swigf_TpetraMap_getMaxLocalIndex(self) & farg1 = self%swigdata fresult = swigc_TpetraMap_getMaxLocalIndex(farg1) -swig_result = fresult +swig_result = int(fresult) end function function swigf_TpetraMap_getMinGlobalIndex(self) & @@ -5040,7 +5036,7 @@ function swigf_TpetraMap_getMaxAllGlobalIndex(self) & function swigf_TpetraMap_getLocalElement(self, globalindex) & result(swig_result) use, intrinsic :: ISO_C_BINDING -integer(C_INT) :: swig_result +integer :: swig_result class(TpetraMap), intent(in) :: self integer(C_LONG_LONG), intent(in) :: globalindex @@ -5052,7 +5048,7 @@ function swigf_TpetraMap_getLocalElement(self, globalindex) & farg1 = self%swigdata farg2 = globalindex fresult = swigc_TpetraMap_getLocalElement(farg1, farg2) -swig_result = fresult +swig_result = int(fresult) end function function swigf_TpetraMap_getGlobalElement(self, localindex) & @@ -5061,14 +5057,14 @@ function swigf_TpetraMap_getGlobalElement(self, localindex) & integer(C_LONG_LONG) :: swig_result class(TpetraMap), intent(in) :: self -integer(C_INT), intent(in) :: localindex +integer, intent(in) :: localindex integer(C_LONG_LONG) :: fresult type(SwigClassWrapper) :: farg1 integer(C_INT) :: farg2 farg1 = self%swigdata -farg2 = localindex +farg2 = int(localindex, C_INT) fresult = swigc_TpetraMap_getGlobalElement(farg1, farg2) swig_result = fresult end function @@ -5079,14 +5075,14 @@ function swigf_TpetraMap_isNodeLocalElement(self, localindex) & logical :: swig_result class(TpetraMap), intent(in) :: self -integer(C_INT), intent(in) :: localindex +integer, intent(in) :: localindex integer(C_INT) :: fresult type(SwigClassWrapper) :: farg1 integer(C_INT) :: farg2 farg1 = self%swigdata -farg2 = localindex +farg2 = int(localindex, C_INT) fresult = swigc_TpetraMap_isNodeLocalElement(farg1, farg2) swig_result = SWIG_int_to_logical(fresult) end function @@ -5327,16 +5323,16 @@ function new_TpetraMap__SWIG_3(numglobalelements, numlocalelements, comm) & use, intrinsic :: ISO_C_BINDING type(TpetraMap) :: self integer(C_LONG), intent(in) :: numglobalelements -integer(C_SIZE_T), intent(in) :: numlocalelements +integer, intent(in) :: numlocalelements class(TeuchosComm), intent(in) :: comm type(SwigClassWrapper) :: fresult integer(C_LONG) :: farg1 -integer(C_SIZE_T) :: farg2 +integer(C_INT) :: farg2 type(SwigClassWrapper) :: farg3 farg1 = numglobalelements -farg2 = numlocalelements +farg2 = int(numlocalelements, C_INT) farg3 = comm%swigdata fresult = swigc_new_TpetraMap__SWIG_3(farg1, farg2, farg3) self%swigdata = fresult @@ -5978,7 +5974,7 @@ function new_TpetraMultiVector__SWIG_4(source, copyorview) & type(TpetraMultiVector) :: self class(TpetraMultiVector), intent(in) :: source -integer(SWIGTYPE_Teuchos__DataAccess), intent(in) :: copyorview +integer(TeuchosDataAccess), intent(in) :: copyorview type(SwigClassWrapper) :: fresult type(SwigClassWrapper) :: farg1 @@ -6152,7 +6148,7 @@ subroutine swigf_TpetraMultiVector_replaceLocalValue(self, lclrow, col, value) use, intrinsic :: ISO_C_BINDING class(TpetraMultiVector), intent(in) :: self -integer(C_INT), intent(in) :: lclrow +integer, intent(in) :: lclrow integer(C_SIZE_T), intent(in) :: col real(C_DOUBLE), intent(in) :: value @@ -6162,7 +6158,7 @@ subroutine swigf_TpetraMultiVector_replaceLocalValue(self, lclrow, col, value) real(C_DOUBLE) :: farg4 farg1 = self%swigdata -farg2 = lclrow +farg2 = int(lclrow, C_INT) farg3 = col farg4 = value call swigc_TpetraMultiVector_replaceLocalValue(farg1, farg2, farg3, farg4) @@ -6172,7 +6168,7 @@ subroutine swigf_TpetraMultiVector_sumIntoLocalValue__SWIG_0(self, lclrow, col, use, intrinsic :: ISO_C_BINDING class(TpetraMultiVector), intent(in) :: self -integer(C_INT), intent(in) :: lclrow +integer, intent(in) :: lclrow integer(C_SIZE_T), intent(in) :: col real(C_DOUBLE), intent(in) :: val logical, intent(in) :: atomic @@ -6184,7 +6180,7 @@ subroutine swigf_TpetraMultiVector_sumIntoLocalValue__SWIG_0(self, lclrow, col, integer(C_INT) :: farg5 farg1 = self%swigdata -farg2 = lclrow +farg2 = int(lclrow, C_INT) farg3 = col farg4 = val farg5 = SWIG_logical_to_int(atomic) @@ -6195,7 +6191,7 @@ subroutine swigf_TpetraMultiVector_sumIntoLocalValue__SWIG_1(self, lclrow, col, use, intrinsic :: ISO_C_BINDING class(TpetraMultiVector), intent(in) :: self -integer(C_INT), intent(in) :: lclrow +integer, intent(in) :: lclrow integer(C_SIZE_T), intent(in) :: col real(C_DOUBLE), intent(in) :: val @@ -6205,7 +6201,7 @@ subroutine swigf_TpetraMultiVector_sumIntoLocalValue__SWIG_1(self, lclrow, col, real(C_DOUBLE) :: farg4 farg1 = self%swigdata -farg2 = lclrow +farg2 = int(lclrow, C_INT) farg3 = col farg4 = val call swigc_TpetraMultiVector_sumIntoLocalValue__SWIG_1(farg1, farg2, farg3, farg4) @@ -6276,69 +6272,6 @@ subroutine swigf_TpetraMultiVector_reduce(self) call swigc_TpetraMultiVector_reduce(farg1) end subroutine -function swigf_TpetraMultiVector_subCopy(self, cols) & -result(swig_result) -use, intrinsic :: ISO_C_BINDING -type(TpetraMultiVector) :: swig_result -class(TpetraMultiVector), intent(in) :: self - -integer(C_LONG), dimension(:), target :: cols -integer(C_LONG), pointer :: farg2_view - -type(SwigClassWrapper) :: fresult -type(SwigClassWrapper) :: farg1 -type(SwigArrayWrapper) :: farg2 - -farg1 = self%swigdata -farg2_view => cols(1) -farg2%data = c_loc(farg2_view) -farg2%size = size(cols) -fresult = swigc_TpetraMultiVector_subCopy(farg1, farg2) -swig_result%swigdata = fresult -end function - -function swigf_TpetraMultiVector_subView(self, cols) & -result(swig_result) -use, intrinsic :: ISO_C_BINDING -type(TpetraMultiVector) :: swig_result -class(TpetraMultiVector), intent(in) :: self - -integer(C_LONG), dimension(:), target :: cols -integer(C_LONG), pointer :: farg2_view - -type(SwigClassWrapper) :: fresult -type(SwigClassWrapper) :: farg1 -type(SwigArrayWrapper) :: farg2 - -farg1 = self%swigdata -farg2_view => cols(1) -farg2%data = c_loc(farg2_view) -farg2%size = size(cols) -fresult = swigc_TpetraMultiVector_subView(farg1, farg2) -swig_result%swigdata = fresult -end function - -function swigf_TpetraMultiVector_subViewNonConst(self, cols) & -result(swig_result) -use, intrinsic :: ISO_C_BINDING -type(TpetraMultiVector) :: swig_result -class(TpetraMultiVector), intent(inout) :: self - -integer(C_LONG), dimension(:), target :: cols -integer(C_LONG), pointer :: farg2_view - -type(SwigClassWrapper) :: fresult -type(SwigClassWrapper) :: farg1 -type(SwigArrayWrapper) :: farg2 - -farg1 = self%swigdata -farg2_view => cols(1) -farg2%data = c_loc(farg2_view) -farg2%size = size(cols) -fresult = swigc_TpetraMultiVector_subViewNonConst(farg1, farg2) -swig_result%swigdata = fresult -end function - function swigf_TpetraMultiVector_offsetView(self, submap, offset) & result(swig_result) use, intrinsic :: ISO_C_BINDING @@ -6813,8 +6746,8 @@ subroutine swigf_TpetraMultiVector_multiply(self, transa, transb, alpha, a, b, b use, intrinsic :: ISO_C_BINDING class(TpetraMultiVector), intent(inout) :: self -integer(SWIGTYPE_Teuchos__ETransp), intent(in) :: transa -integer(SWIGTYPE_Teuchos__ETransp), intent(in) :: transb +integer(TeuchosETransp), intent(in) :: transa +integer(TeuchosETransp), intent(in) :: transb real(C_DOUBLE), intent(in) :: alpha class(TpetraMultiVector), intent(in) :: a @@ -6857,15 +6790,15 @@ function swigf_TpetraMultiVector_getNumVectors(self) & function swigf_TpetraMultiVector_getLocalLength(self) & result(swig_result) use, intrinsic :: ISO_C_BINDING -integer(C_SIZE_T) :: swig_result +integer :: swig_result class(TpetraMultiVector), intent(in) :: self -integer(C_SIZE_T) :: fresult +integer(C_INT) :: fresult type(SwigClassWrapper) :: farg1 farg1 = self%swigdata fresult = swigc_TpetraMultiVector_getLocalLength(farg1) -swig_result = fresult +swig_result = int(fresult) end function function swigf_TpetraMultiVector_getGlobalLength(self) & @@ -6943,7 +6876,7 @@ subroutine swigf_TpetraMultiVector_setCopyOrView(self, copyorview) use, intrinsic :: ISO_C_BINDING class(TpetraMultiVector), intent(inout) :: self -integer(SWIGTYPE_Teuchos__DataAccess), intent(in) :: copyorview +integer(TeuchosDataAccess), intent(in) :: copyorview type(SwigClassWrapper) :: farg1 integer(C_INT) :: farg2 @@ -6956,7 +6889,7 @@ subroutine swigf_TpetraMultiVector_setCopyOrView(self, copyorview) function swigf_TpetraMultiVector_getCopyOrView(self) & result(swig_result) use, intrinsic :: ISO_C_BINDING -integer(SWIGTYPE_Teuchos__DataAccess) :: swig_result +integer(TeuchosDataAccess) :: swig_result class(TpetraMultiVector), intent(in) :: self integer(C_INT) :: fresult @@ -6985,6 +6918,69 @@ function swigf_TpetraMultiVector_isSameSize(self, vec) & swig_result = SWIG_int_to_logical(fresult) end function +function swigf_TpetraMultiVector_subCopy(self, cols) & +result(swig_result) +use, intrinsic :: ISO_C_BINDING +type(TpetraMultiVector) :: swig_result +class(TpetraMultiVector), intent(in) :: self + +integer(C_SIZE_T), dimension(:), target :: cols +integer(C_SIZE_T), pointer :: farg2_view + +type(SwigClassWrapper) :: fresult +type(SwigClassWrapper) :: farg1 +type(SwigArrayWrapper) :: farg2 + +farg1 = self%swigdata +farg2_view => cols(1) +farg2%data = c_loc(farg2_view) +farg2%size = size(cols) +fresult = swigc_TpetraMultiVector_subCopy(farg1, farg2) +swig_result%swigdata = fresult +end function + +function swigf_TpetraMultiVector_subView(self, cols) & +result(swig_result) +use, intrinsic :: ISO_C_BINDING +type(TpetraMultiVector) :: swig_result +class(TpetraMultiVector), intent(in) :: self + +integer(C_SIZE_T), dimension(:), target :: cols +integer(C_SIZE_T), pointer :: farg2_view + +type(SwigClassWrapper) :: fresult +type(SwigClassWrapper) :: farg1 +type(SwigArrayWrapper) :: farg2 + +farg1 = self%swigdata +farg2_view => cols(1) +farg2%data = c_loc(farg2_view) +farg2%size = size(cols) +fresult = swigc_TpetraMultiVector_subView(farg1, farg2) +swig_result%swigdata = fresult +end function + +function swigf_TpetraMultiVector_subViewNonConst(self, cols) & +result(swig_result) +use, intrinsic :: ISO_C_BINDING +type(TpetraMultiVector) :: swig_result +class(TpetraMultiVector), intent(inout) :: self + +integer(C_SIZE_T), dimension(:), target :: cols +integer(C_SIZE_T), pointer :: farg2_view + +type(SwigClassWrapper) :: fresult +type(SwigClassWrapper) :: farg1 +type(SwigArrayWrapper) :: farg2 + +farg1 = self%swigdata +farg2_view => cols(1) +farg2%data = c_loc(farg2_view) +farg2%size = size(cols) +fresult = swigc_TpetraMultiVector_subViewNonConst(farg1, farg2) +swig_result%swigdata = fresult +end function + subroutine swigf_TpetraMultiVector_doImport__SWIG_0(self, source, importer, cm) use, intrinsic :: ISO_C_BINDING class(TpetraMultiVector), intent(inout) :: self @@ -7174,7 +7170,7 @@ subroutine swigf_ForTpetraOperator_apply(self, x, y, mode, alpha, beta) class(TpetraMultiVector), intent(inout) :: y -integer(SWIGTYPE_Teuchos__ETransp), intent(in) :: mode +integer(TeuchosETransp), intent(in) :: mode real(C_DOUBLE), intent(in) :: alpha real(C_DOUBLE), intent(in) :: beta @@ -7690,7 +7686,7 @@ subroutine swigf_TpetraCrsGraph_insertGlobalIndices__SWIG_0(self, globalrow, num class(TpetraCrsGraph), intent(inout) :: self integer(C_LONG_LONG), intent(in) :: globalrow -integer(C_INT), intent(in) :: nument +integer, intent(in) :: nument integer(C_LONG_LONG), dimension(*), target, intent(in) :: inds type(SwigClassWrapper) :: farg1 @@ -7700,7 +7696,7 @@ subroutine swigf_TpetraCrsGraph_insertGlobalIndices__SWIG_0(self, globalrow, num farg1 = self%swigdata farg2 = globalrow -farg3 = nument +farg3 = int(nument, C_INT) farg4 = c_loc(inds(1)) call swigc_TpetraCrsGraph_insertGlobalIndices__SWIG_0(farg1, farg2, farg3, farg4) end subroutine @@ -7709,13 +7705,13 @@ subroutine swigf_TpetraCrsGraph_removeLocalIndices(self, localrow) use, intrinsic :: ISO_C_BINDING class(TpetraCrsGraph), intent(inout) :: self -integer(C_INT), intent(in) :: localrow +integer, intent(in) :: localrow type(SwigClassWrapper) :: farg1 integer(C_INT) :: farg2 farg1 = self%swigdata -farg2 = localrow +farg2 = int(localrow, C_INT) call swigc_TpetraCrsGraph_removeLocalIndices(farg1, farg2) end subroutine @@ -8116,19 +8112,19 @@ function swigf_TpetraCrsGraph_getNumEntriesInGlobalRow(self, globalrow) & function swigf_TpetraCrsGraph_getNumEntriesInLocalRow(self, localrow) & result(swig_result) use, intrinsic :: ISO_C_BINDING -integer(C_SIZE_T) :: swig_result +integer :: swig_result class(TpetraCrsGraph), intent(in) :: self -integer(C_INT), intent(in) :: localrow +integer, intent(in) :: localrow -integer(C_SIZE_T) :: fresult +integer(C_INT) :: fresult type(SwigClassWrapper) :: farg1 integer(C_INT) :: farg2 farg1 = self%swigdata -farg2 = localrow +farg2 = int(localrow, C_INT) fresult = swigc_TpetraCrsGraph_getNumEntriesInLocalRow(farg1, farg2) -swig_result = fresult +swig_result = int(fresult) end function function swigf_TpetraCrsGraph_getNodeAllocationSize(self) & @@ -8166,19 +8162,19 @@ function swigf_TpetraCrsGraph_getNumAllocatedEntriesInGlobalRow(self, globalrow) function swigf_TpetraCrsGraph_getNumAllocatedEntriesInLocalRow(self, localrow) & result(swig_result) use, intrinsic :: ISO_C_BINDING -integer(C_SIZE_T) :: swig_result +integer :: swig_result class(TpetraCrsGraph), intent(in) :: self -integer(C_INT), intent(in) :: localrow +integer, intent(in) :: localrow -integer(C_SIZE_T) :: fresult +integer(C_INT) :: fresult type(SwigClassWrapper) :: farg1 integer(C_INT) :: farg2 farg1 = self%swigdata -farg2 = localrow +farg2 = int(localrow, C_INT) fresult = swigc_TpetraCrsGraph_getNumAllocatedEntriesInLocalRow(farg1, farg2) -swig_result = fresult +swig_result = int(fresult) end function function swigf_TpetraCrsGraph_getGlobalNumDiags(self) & @@ -9057,7 +9053,7 @@ subroutine swigf_TpetraCrsGraph_insertLocalIndices(self, localrow, indices) use, intrinsic :: ISO_C_BINDING class(TpetraCrsGraph), intent(inout) :: self -integer(C_INT), intent(in) :: localrow +integer, intent(in) :: localrow integer(C_INT), dimension(:), target :: indices integer(C_INT), pointer :: farg3_view @@ -9066,7 +9062,7 @@ subroutine swigf_TpetraCrsGraph_insertLocalIndices(self, localrow, indices) type(SwigArrayWrapper) :: farg3 farg1 = self%swigdata -farg2 = localrow +farg2 = int(localrow, C_INT) farg3_view => indices(1) farg3%data = c_loc(farg3_view) farg3%size = size(indices) @@ -9100,7 +9096,7 @@ subroutine swigf_TpetraCrsGraph_getLocalRowCopy(self, localrow, indices, numindi use, intrinsic :: ISO_C_BINDING class(TpetraCrsGraph), intent(in) :: self -integer(C_INT), intent(in) :: localrow +integer, intent(in) :: localrow integer(C_INT), dimension(:), target :: indices integer(C_INT), pointer :: farg3_view integer(C_SIZE_T), target, intent(inout) :: numindices @@ -9111,7 +9107,7 @@ subroutine swigf_TpetraCrsGraph_getLocalRowCopy(self, localrow, indices, numindi type(C_PTR) :: farg4 farg1 = self%swigdata -farg2 = localrow +farg2 = int(localrow, C_INT) farg3_view => indices(1) farg3%data = c_loc(farg3_view) farg3%size = size(indices) @@ -10032,19 +10028,19 @@ function swigf_TpetraCrsMatrix_getNumEntriesInGlobalRow(self, globalrow) & function swigf_TpetraCrsMatrix_getNumEntriesInLocalRow(self, localrow) & result(swig_result) use, intrinsic :: ISO_C_BINDING -integer(C_SIZE_T) :: swig_result +integer :: swig_result class(TpetraCrsMatrix), intent(in) :: self -integer(C_INT), intent(in) :: localrow +integer, intent(in) :: localrow -integer(C_SIZE_T) :: fresult +integer(C_INT) :: fresult type(SwigClassWrapper) :: farg1 integer(C_INT) :: farg2 farg1 = self%swigdata -farg2 = localrow +farg2 = int(localrow, C_INT) fresult = swigc_TpetraCrsMatrix_getNumEntriesInLocalRow(farg1, farg2) -swig_result = fresult +swig_result = int(fresult) end function function swigf_TpetraCrsMatrix_getGlobalNumDiagsImpl(self) & @@ -10335,7 +10331,7 @@ subroutine swigf_TpetraCrsMatrix_apply__SWIG_0(self, x, y, mode, alpha, beta) class(TpetraMultiVector), intent(inout) :: y -integer(SWIGTYPE_Teuchos__ETransp), intent(in) :: mode +integer(TeuchosETransp), intent(in) :: mode real(C_DOUBLE), intent(in) :: alpha real(C_DOUBLE), intent(in) :: beta @@ -10363,7 +10359,7 @@ subroutine swigf_TpetraCrsMatrix_apply__SWIG_1(self, x, y, mode, alpha) class(TpetraMultiVector), intent(inout) :: y -integer(SWIGTYPE_Teuchos__ETransp), intent(in) :: mode +integer(TeuchosETransp), intent(in) :: mode real(C_DOUBLE), intent(in) :: alpha type(SwigClassWrapper) :: farg1 @@ -10388,7 +10384,7 @@ subroutine swigf_TpetraCrsMatrix_apply__SWIG_2(self, x, y, mode) class(TpetraMultiVector), intent(inout) :: y -integer(SWIGTYPE_Teuchos__ETransp), intent(in) :: mode +integer(TeuchosETransp), intent(in) :: mode type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 @@ -10474,7 +10470,7 @@ subroutine swigf_TpetraCrsMatrix_gaussSeidel(self, b, x, d, dampingfactor, direc real(C_DOUBLE), intent(in) :: dampingfactor integer(TpetraESweepDirection), intent(in) :: direction -integer(C_INT), intent(in) :: numsweeps +integer, intent(in) :: numsweeps type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 @@ -10490,7 +10486,7 @@ subroutine swigf_TpetraCrsMatrix_gaussSeidel(self, b, x, d, dampingfactor, direc farg4 = d%swigdata farg5 = dampingfactor farg6 = direction -farg7 = numsweeps +farg7 = int(numsweeps, C_INT) call swigc_TpetraCrsMatrix_gaussSeidel(farg1, farg2, farg3, farg4, farg5, farg6, farg7) end subroutine @@ -10506,7 +10502,7 @@ subroutine swigf_TpetraCrsMatrix_gaussSeidelCopy(self, x, b, d, dampingfactor, d real(C_DOUBLE), intent(in) :: dampingfactor integer(TpetraESweepDirection), intent(in) :: direction -integer(C_INT), intent(in) :: numsweeps +integer, intent(in) :: numsweeps logical, intent(in) :: zeroinitialguess type(SwigClassWrapper) :: farg1 @@ -10524,7 +10520,7 @@ subroutine swigf_TpetraCrsMatrix_gaussSeidelCopy(self, x, b, d, dampingfactor, d farg4 = d%swigdata farg5 = dampingfactor farg6 = direction -farg7 = numsweeps +farg7 = int(numsweeps, C_INT) farg8 = SWIG_logical_to_int(zeroinitialguess) call swigc_TpetraCrsMatrix_gaussSeidelCopy(farg1, farg2, farg3, farg4, farg5, farg6, farg7, farg8) end subroutine @@ -11053,7 +11049,7 @@ subroutine swigf_TpetraCrsMatrix_insertLocalValues(self, localrow, cols, vals) use, intrinsic :: ISO_C_BINDING class(TpetraCrsMatrix), intent(inout) :: self -integer(C_INT), intent(in) :: localrow +integer, intent(in) :: localrow integer(C_INT), dimension(:), target :: cols integer(C_INT), pointer :: farg3_view real(C_DOUBLE), dimension(:), target :: vals @@ -11065,7 +11061,7 @@ subroutine swigf_TpetraCrsMatrix_insertLocalValues(self, localrow, cols, vals) type(SwigArrayWrapper) :: farg4 farg1 = self%swigdata -farg2 = localrow +farg2 = int(localrow, C_INT) farg3_view => cols(1) farg3%data = c_loc(farg3_view) farg3%size = size(cols) @@ -11078,7 +11074,7 @@ subroutine swigf_TpetraCrsMatrix_insertLocalValues(self, localrow, cols, vals) function swigf_TpetraCrsMatrix_replaceGlobalValues(self, globalrow, cols, vals) & result(swig_result) use, intrinsic :: ISO_C_BINDING -integer(C_INT) :: swig_result +integer :: swig_result class(TpetraCrsMatrix), intent(in) :: self integer(C_LONG_LONG), intent(in) :: globalrow @@ -11102,13 +11098,13 @@ function swigf_TpetraCrsMatrix_replaceGlobalValues(self, globalrow, cols, vals) farg4%data = c_loc(farg4_view) farg4%size = size(vals) fresult = swigc_TpetraCrsMatrix_replaceGlobalValues(farg1, farg2, farg3, farg4) -swig_result = fresult +swig_result = int(fresult) end function function swigf_TpetraCrsMatrix_sumIntoGlobalValues(self, globalrow, cols, vals) & result(swig_result) use, intrinsic :: ISO_C_BINDING -integer(C_INT) :: swig_result +integer :: swig_result class(TpetraCrsMatrix), intent(inout) :: self integer(C_LONG_LONG), intent(in) :: globalrow @@ -11132,7 +11128,7 @@ function swigf_TpetraCrsMatrix_sumIntoGlobalValues(self, globalrow, cols, vals) farg4%data = c_loc(farg4_view) farg4%size = size(vals) fresult = swigc_TpetraCrsMatrix_sumIntoGlobalValues(farg1, farg2, farg3, farg4) -swig_result = fresult +swig_result = int(fresult) end function subroutine swigf_TpetraCrsMatrix_setAllValues(self, ptr, ind, val) @@ -11226,7 +11222,7 @@ subroutine swigf_TpetraCrsMatrix_getLocalRowCopy(self, localrow, colinds, vals, use, intrinsic :: ISO_C_BINDING class(TpetraCrsMatrix), intent(in) :: self -integer(C_INT), intent(in) :: localrow +integer, intent(in) :: localrow integer(C_INT), dimension(:), target :: colinds integer(C_INT), pointer :: farg3_view real(C_DOUBLE), dimension(:), target :: vals @@ -11240,7 +11236,7 @@ subroutine swigf_TpetraCrsMatrix_getLocalRowCopy(self, localrow, colinds, vals, type(C_PTR) :: farg5 farg1 = self%swigdata -farg2 = localrow +farg2 = int(localrow, C_INT) farg3_view => colinds(1) farg3%data = c_loc(farg3_view) farg3%size = size(colinds) diff --git a/src/tpetra/src/swig/fortpetraFORTRAN_wrap.cxx b/src/tpetra/src/swig/fortpetraFORTRAN_wrap.cxx index 42dfbc7d..ec37e92a 100644 --- a/src/tpetra/src/swig/fortpetraFORTRAN_wrap.cxx +++ b/src/tpetra/src/swig/fortpetraFORTRAN_wrap.cxx @@ -621,6 +621,24 @@ using Tpetra::Import; #include "Tpetra_MultiVector.hpp" +SWIGINTERN Teuchos::RCP< Tpetra::MultiVector< SC,LO,GO,NO > > Tpetra_MultiVector_Sl_SC_Sc_LO_Sc_GO_Sc_NO_Sg__subCopy(Tpetra::MultiVector< SC,LO,GO,NO > const *self,std::pair< std::size_t const *,std::size_t > cols){ + Teuchos::Array colsArray(cols.second); + for (int i = 0; i < colsArray.size(); i++) + colsArray[i] = cols.first[i]-1; + return self->subCopy(colsArray); + } +SWIGINTERN Teuchos::RCP< Tpetra::MultiVector< SC,LO,GO,NO > const > Tpetra_MultiVector_Sl_SC_Sc_LO_Sc_GO_Sc_NO_Sg__subView(Tpetra::MultiVector< SC,LO,GO,NO > const *self,std::pair< std::size_t const *,std::size_t > cols){ + Teuchos::Array colsArray(cols.second); + for (int i = 0; i < colsArray.size(); i++) + colsArray[i] = cols.first[i]-1; + return self->subView(colsArray); + } +SWIGINTERN Teuchos::RCP< Tpetra::MultiVector< SC,LO,GO,NO > > Tpetra_MultiVector_Sl_SC_Sc_LO_Sc_GO_Sc_NO_Sg__subViewNonConst(Tpetra::MultiVector< SC,LO,GO,NO > *self,std::pair< std::size_t const *,std::size_t > cols){ + Teuchos::Array colsArray(cols.second); + for (int i = 0; i < colsArray.size(); i++) + colsArray[i] = cols.first[i]-1; + return self->subViewNonConst(colsArray); + } SWIGINTERN void Tpetra_MultiVector_Sl_SC_Sc_LO_Sc_GO_Sc_NO_Sg__doImport__SWIG_0(Tpetra::MultiVector< SC,LO,GO,NO > *self,Tpetra::MultiVector< SC,LO,GO,NO > const &source,Tpetra::Import< LO,GO,NO > const &importer,Tpetra::CombineMode CM){ self->doImport(source, importer, CM); } @@ -1225,8 +1243,8 @@ SWIGEXPORT long _wrap_TpetraMap_getGlobalNumElements(SwigClassWrapper const *far } -SWIGEXPORT size_t _wrap_TpetraMap_getNodeNumElements(SwigClassWrapper const *farg1) { - size_t fresult ; +SWIGEXPORT int _wrap_TpetraMap_getNodeNumElements(SwigClassWrapper const *farg1) { + int fresult ; Tpetra::Map< LO,GO,NO > *arg1 = (Tpetra::Map< LO,GO,NO > *) 0 ; Teuchos::RCP< Tpetra::Map< LO,GO,NO > const > *smartarg1 ; size_t result; @@ -2135,7 +2153,7 @@ SWIGEXPORT SwigClassWrapper _wrap_new_TpetraMap__SWIG_2(long const *farg1, SwigC } -SWIGEXPORT SwigClassWrapper _wrap_new_TpetraMap__SWIG_3(long const *farg1, size_t const *farg2, SwigClassWrapper const *farg3) { +SWIGEXPORT SwigClassWrapper _wrap_new_TpetraMap__SWIG_3(long const *farg1, int const *farg2, SwigClassWrapper const *farg3) { SwigClassWrapper fresult ; Tpetra::global_size_t arg1 ; size_t arg2 ; @@ -4265,135 +4283,6 @@ SWIGEXPORT void _wrap_TpetraMultiVector_reduce(SwigClassWrapper const *farg1) { } -SWIGEXPORT SwigClassWrapper _wrap_TpetraMultiVector_subCopy(SwigClassWrapper const *farg1, SwigArrayWrapper *farg2) { - SwigClassWrapper fresult ; - Tpetra::MultiVector< SC,LO,GO,NO > *arg1 = (Tpetra::MultiVector< SC,LO,GO,NO > *) 0 ; - Teuchos::ArrayView< std::size_t const > *arg2 = 0 ; - Teuchos::RCP< Tpetra::MultiVector< SC,LO,GO,NO > const > *smartarg1 ; - unsigned long const *tempbegin2 ; - Teuchos::ArrayView< unsigned long const > temparr2 ; - Teuchos::RCP< Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > > result; - - smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); - arg1 = smartarg1 ? const_cast< Tpetra::MultiVector* >(smartarg1->get()) : NULL; - tempbegin2 = static_cast(farg2->data); - temparr2 = Teuchos::ArrayView(tempbegin2, farg2->size); - arg2 = &temparr2; - { - // Make sure no unhandled exceptions exist before performing a new action - SWIG_check_unhandled_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::subCopy(Teuchos::ArrayView< std::size_t const > const &) const");; - try - { - // Attempt the wrapped function call - result = ((Tpetra::MultiVector< SC,LO,GO,NO > const *)arg1)->subCopy((Teuchos::ArrayView< std::size_t const > const &)*arg2); - } - catch (const std::range_error& e) - { - // Store a C++ exception - SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::subCopy(Teuchos::ArrayView< std::size_t const > const &) const", SWIG_IndexError, e.what(), return SwigClassWrapper_uninitialized()); - } - catch (const std::exception& e) - { - // Store a C++ exception - SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::subCopy(Teuchos::ArrayView< std::size_t const > const &) const", SWIG_RuntimeError, e.what(), return SwigClassWrapper_uninitialized()); - } - catch (...) - { - SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::subCopy(Teuchos::ArrayView< std::size_t const > const &) const", SWIG_UnknownError, "An unknown exception occurred", return SwigClassWrapper_uninitialized()); - } - } - fresult.cptr = (new Teuchos::RCP< Tpetra::MultiVector >(static_cast< const Teuchos::RCP< Tpetra::MultiVector >& >(result))); - fresult.mem = SWIG_MOVE; - return fresult; -} - - -SWIGEXPORT SwigClassWrapper _wrap_TpetraMultiVector_subView(SwigClassWrapper const *farg1, SwigArrayWrapper *farg2) { - SwigClassWrapper fresult ; - Tpetra::MultiVector< SC,LO,GO,NO > *arg1 = (Tpetra::MultiVector< SC,LO,GO,NO > *) 0 ; - Teuchos::ArrayView< std::size_t const > *arg2 = 0 ; - Teuchos::RCP< Tpetra::MultiVector< SC,LO,GO,NO > const > *smartarg1 ; - unsigned long const *tempbegin2 ; - Teuchos::ArrayView< unsigned long const > temparr2 ; - Teuchos::RCP< Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const > result; - - smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); - arg1 = smartarg1 ? const_cast< Tpetra::MultiVector* >(smartarg1->get()) : NULL; - tempbegin2 = static_cast(farg2->data); - temparr2 = Teuchos::ArrayView(tempbegin2, farg2->size); - arg2 = &temparr2; - { - // Make sure no unhandled exceptions exist before performing a new action - SWIG_check_unhandled_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::subView(Teuchos::ArrayView< std::size_t const > const &) const");; - try - { - // Attempt the wrapped function call - result = ((Tpetra::MultiVector< SC,LO,GO,NO > const *)arg1)->subView((Teuchos::ArrayView< std::size_t const > const &)*arg2); - } - catch (const std::range_error& e) - { - // Store a C++ exception - SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::subView(Teuchos::ArrayView< std::size_t const > const &) const", SWIG_IndexError, e.what(), return SwigClassWrapper_uninitialized()); - } - catch (const std::exception& e) - { - // Store a C++ exception - SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::subView(Teuchos::ArrayView< std::size_t const > const &) const", SWIG_RuntimeError, e.what(), return SwigClassWrapper_uninitialized()); - } - catch (...) - { - SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::subView(Teuchos::ArrayView< std::size_t const > const &) const", SWIG_UnknownError, "An unknown exception occurred", return SwigClassWrapper_uninitialized()); - } - } - fresult.cptr = (new Teuchos::RCP >(static_cast< const Teuchos::RCP >& >(result))); - fresult.mem = SWIG_MOVE; - return fresult; -} - - -SWIGEXPORT SwigClassWrapper _wrap_TpetraMultiVector_subViewNonConst(SwigClassWrapper const *farg1, SwigArrayWrapper *farg2) { - SwigClassWrapper fresult ; - Tpetra::MultiVector< SC,LO,GO,NO > *arg1 = (Tpetra::MultiVector< SC,LO,GO,NO > *) 0 ; - Teuchos::ArrayView< std::size_t const > *arg2 = 0 ; - Teuchos::RCP< Tpetra::MultiVector< SC,LO,GO,NO > > *smartarg1 ; - unsigned long const *tempbegin2 ; - Teuchos::ArrayView< unsigned long const > temparr2 ; - Teuchos::RCP< Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > > result; - - smartarg1 = static_cast< Teuchos::RCP< Tpetra::MultiVector >* >(farg1->cptr); - arg1 = smartarg1 ? const_cast< Tpetra::MultiVector* >(smartarg1->get()) : NULL; - tempbegin2 = static_cast(farg2->data); - temparr2 = Teuchos::ArrayView(tempbegin2, farg2->size); - arg2 = &temparr2; - { - // Make sure no unhandled exceptions exist before performing a new action - SWIG_check_unhandled_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::subViewNonConst(Teuchos::ArrayView< std::size_t const > const &)");; - try - { - // Attempt the wrapped function call - result = (arg1)->subViewNonConst((Teuchos::ArrayView< std::size_t const > const &)*arg2); - } - catch (const std::range_error& e) - { - // Store a C++ exception - SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::subViewNonConst(Teuchos::ArrayView< std::size_t const > const &)", SWIG_IndexError, e.what(), return SwigClassWrapper_uninitialized()); - } - catch (const std::exception& e) - { - // Store a C++ exception - SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::subViewNonConst(Teuchos::ArrayView< std::size_t const > const &)", SWIG_RuntimeError, e.what(), return SwigClassWrapper_uninitialized()); - } - catch (...) - { - SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::subViewNonConst(Teuchos::ArrayView< std::size_t const > const &)", SWIG_UnknownError, "An unknown exception occurred", return SwigClassWrapper_uninitialized()); - } - } - fresult.cptr = (new Teuchos::RCP< Tpetra::MultiVector >(static_cast< const Teuchos::RCP< Tpetra::MultiVector >& >(result))); - fresult.mem = SWIG_MOVE; - return fresult; -} - - SWIGEXPORT SwigClassWrapper _wrap_TpetraMultiVector_offsetView(SwigClassWrapper const *farg1, SwigClassWrapper const *farg2, size_t const *farg3) { SwigClassWrapper fresult ; Tpetra::MultiVector< SC,LO,GO,NO > *arg1 = (Tpetra::MultiVector< SC,LO,GO,NO > *) 0 ; @@ -5610,8 +5499,8 @@ SWIGEXPORT size_t _wrap_TpetraMultiVector_getNumVectors(SwigClassWrapper const * } -SWIGEXPORT size_t _wrap_TpetraMultiVector_getLocalLength(SwigClassWrapper const *farg1) { - size_t fresult ; +SWIGEXPORT int _wrap_TpetraMultiVector_getLocalLength(SwigClassWrapper const *farg1) { + int fresult ; Tpetra::MultiVector< SC,LO,GO,NO > *arg1 = (Tpetra::MultiVector< SC,LO,GO,NO > *) 0 ; Teuchos::RCP< Tpetra::MultiVector< SC,LO,GO,NO > const > *smartarg1 ; size_t result; @@ -5944,6 +5833,126 @@ SWIGEXPORT int _wrap_TpetraMultiVector_isSameSize(SwigClassWrapper const *farg1, } +SWIGEXPORT SwigClassWrapper _wrap_TpetraMultiVector_subCopy(SwigClassWrapper const *farg1, SwigArrayWrapper *farg2) { + SwigClassWrapper fresult ; + Tpetra::MultiVector< SC,LO,GO,NO > *arg1 = (Tpetra::MultiVector< SC,LO,GO,NO > *) 0 ; + std::pair< std::size_t const *,std::size_t > arg2 ; + Teuchos::RCP< Tpetra::MultiVector< SC,LO,GO,NO > const > *smartarg1 ; + Teuchos::RCP< Tpetra::MultiVector< SC,LO,GO,NO > > result; + + smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::MultiVector* >(smartarg1->get()) : NULL; + (&arg2)->first = static_cast(farg2->data); + (&arg2)->second = farg2->size; + { + // Make sure no unhandled exceptions exist before performing a new action + SWIG_check_unhandled_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::subCopy(std::pair< std::size_t const *,std::size_t >) const");; + try + { + // Attempt the wrapped function call + result = Tpetra_MultiVector_Sl_SC_Sc_LO_Sc_GO_Sc_NO_Sg__subCopy((Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const *)arg1,arg2); + } + catch (const std::range_error& e) + { + // Store a C++ exception + SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::subCopy(std::pair< std::size_t const *,std::size_t >) const", SWIG_IndexError, e.what(), return SwigClassWrapper_uninitialized()); + } + catch (const std::exception& e) + { + // Store a C++ exception + SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::subCopy(std::pair< std::size_t const *,std::size_t >) const", SWIG_RuntimeError, e.what(), return SwigClassWrapper_uninitialized()); + } + catch (...) + { + SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::subCopy(std::pair< std::size_t const *,std::size_t >) const", SWIG_UnknownError, "An unknown exception occurred", return SwigClassWrapper_uninitialized()); + } + } + fresult.cptr = (new Teuchos::RCP< Tpetra::MultiVector >(static_cast< const Teuchos::RCP< Tpetra::MultiVector >& >(result))); + fresult.mem = SWIG_MOVE; + return fresult; +} + + +SWIGEXPORT SwigClassWrapper _wrap_TpetraMultiVector_subView(SwigClassWrapper const *farg1, SwigArrayWrapper *farg2) { + SwigClassWrapper fresult ; + Tpetra::MultiVector< SC,LO,GO,NO > *arg1 = (Tpetra::MultiVector< SC,LO,GO,NO > *) 0 ; + std::pair< std::size_t const *,std::size_t > arg2 ; + Teuchos::RCP< Tpetra::MultiVector< SC,LO,GO,NO > const > *smartarg1 ; + Teuchos::RCP< Tpetra::MultiVector< SC,LO,GO,NO > const > result; + + smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::MultiVector* >(smartarg1->get()) : NULL; + (&arg2)->first = static_cast(farg2->data); + (&arg2)->second = farg2->size; + { + // Make sure no unhandled exceptions exist before performing a new action + SWIG_check_unhandled_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::subView(std::pair< std::size_t const *,std::size_t >) const");; + try + { + // Attempt the wrapped function call + result = Tpetra_MultiVector_Sl_SC_Sc_LO_Sc_GO_Sc_NO_Sg__subView((Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const *)arg1,arg2); + } + catch (const std::range_error& e) + { + // Store a C++ exception + SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::subView(std::pair< std::size_t const *,std::size_t >) const", SWIG_IndexError, e.what(), return SwigClassWrapper_uninitialized()); + } + catch (const std::exception& e) + { + // Store a C++ exception + SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::subView(std::pair< std::size_t const *,std::size_t >) const", SWIG_RuntimeError, e.what(), return SwigClassWrapper_uninitialized()); + } + catch (...) + { + SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::subView(std::pair< std::size_t const *,std::size_t >) const", SWIG_UnknownError, "An unknown exception occurred", return SwigClassWrapper_uninitialized()); + } + } + fresult.cptr = (new Teuchos::RCP >(static_cast< const Teuchos::RCP >& >(result))); + fresult.mem = SWIG_MOVE; + return fresult; +} + + +SWIGEXPORT SwigClassWrapper _wrap_TpetraMultiVector_subViewNonConst(SwigClassWrapper const *farg1, SwigArrayWrapper *farg2) { + SwigClassWrapper fresult ; + Tpetra::MultiVector< SC,LO,GO,NO > *arg1 = (Tpetra::MultiVector< SC,LO,GO,NO > *) 0 ; + std::pair< std::size_t const *,std::size_t > arg2 ; + Teuchos::RCP< Tpetra::MultiVector< SC,LO,GO,NO > > *smartarg1 ; + Teuchos::RCP< Tpetra::MultiVector< SC,LO,GO,NO > > result; + + smartarg1 = static_cast< Teuchos::RCP< Tpetra::MultiVector >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::MultiVector* >(smartarg1->get()) : NULL; + (&arg2)->first = static_cast(farg2->data); + (&arg2)->second = farg2->size; + { + // Make sure no unhandled exceptions exist before performing a new action + SWIG_check_unhandled_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::subViewNonConst(std::pair< std::size_t const *,std::size_t >)");; + try + { + // Attempt the wrapped function call + result = Tpetra_MultiVector_Sl_SC_Sc_LO_Sc_GO_Sc_NO_Sg__subViewNonConst(arg1,arg2); + } + catch (const std::range_error& e) + { + // Store a C++ exception + SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::subViewNonConst(std::pair< std::size_t const *,std::size_t >)", SWIG_IndexError, e.what(), return SwigClassWrapper_uninitialized()); + } + catch (const std::exception& e) + { + // Store a C++ exception + SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::subViewNonConst(std::pair< std::size_t const *,std::size_t >)", SWIG_RuntimeError, e.what(), return SwigClassWrapper_uninitialized()); + } + catch (...) + { + SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::subViewNonConst(std::pair< std::size_t const *,std::size_t >)", SWIG_UnknownError, "An unknown exception occurred", return SwigClassWrapper_uninitialized()); + } + } + fresult.cptr = (new Teuchos::RCP< Tpetra::MultiVector >(static_cast< const Teuchos::RCP< Tpetra::MultiVector >& >(result))); + fresult.mem = SWIG_MOVE; + return fresult; +} + + SWIGEXPORT void _wrap_TpetraMultiVector_doImport__SWIG_0(SwigClassWrapper const *farg1, SwigClassWrapper const *farg2, SwigClassWrapper const *farg3, int const *farg4) { Tpetra::MultiVector< SC,LO,GO,NO > *arg1 = (Tpetra::MultiVector< SC,LO,GO,NO > *) 0 ; Tpetra::MultiVector< SC,LO,GO,NO > *arg2 = 0 ; @@ -8063,8 +8072,8 @@ SWIGEXPORT size_t _wrap_TpetraCrsGraph_getNumEntriesInGlobalRow(SwigClassWrapper } -SWIGEXPORT size_t _wrap_TpetraCrsGraph_getNumEntriesInLocalRow(SwigClassWrapper const *farg1, int const *farg2) { - size_t fresult ; +SWIGEXPORT int _wrap_TpetraCrsGraph_getNumEntriesInLocalRow(SwigClassWrapper const *farg1, int const *farg2) { + int fresult ; Tpetra::CrsGraph< LO,GO,NO > *arg1 = (Tpetra::CrsGraph< LO,GO,NO > *) 0 ; int arg2 ; Teuchos::RCP< Tpetra::CrsGraph< LO,GO,NO > const > *smartarg1 ; @@ -8175,8 +8184,8 @@ SWIGEXPORT size_t _wrap_TpetraCrsGraph_getNumAllocatedEntriesInGlobalRow(SwigCla } -SWIGEXPORT size_t _wrap_TpetraCrsGraph_getNumAllocatedEntriesInLocalRow(SwigClassWrapper const *farg1, int const *farg2) { - size_t fresult ; +SWIGEXPORT int _wrap_TpetraCrsGraph_getNumAllocatedEntriesInLocalRow(SwigClassWrapper const *farg1, int const *farg2) { + int fresult ; Tpetra::CrsGraph< LO,GO,NO > *arg1 = (Tpetra::CrsGraph< LO,GO,NO > *) 0 ; int arg2 ; Teuchos::RCP< Tpetra::CrsGraph< LO,GO,NO > const > *smartarg1 ; @@ -12089,8 +12098,8 @@ SWIGEXPORT size_t _wrap_TpetraCrsMatrix_getNumEntriesInGlobalRow(SwigClassWrappe } -SWIGEXPORT size_t _wrap_TpetraCrsMatrix_getNumEntriesInLocalRow(SwigClassWrapper const *farg1, int const *farg2) { - size_t fresult ; +SWIGEXPORT int _wrap_TpetraCrsMatrix_getNumEntriesInLocalRow(SwigClassWrapper const *farg1, int const *farg2) { + int fresult ; Tpetra::CrsMatrix< SC,LO,GO,NO > *arg1 = (Tpetra::CrsMatrix< SC,LO,GO,NO > *) 0 ; int arg2 ; Teuchos::RCP< Tpetra::CrsMatrix< SC,LO,GO,NO > const > *smartarg1 ; diff --git a/src/tpetra/test/test_tpetra_crsgraph.F90 b/src/tpetra/test/test_tpetra_crsgraph.F90 index ea7f231e..7c5e8aad 100644 --- a/src/tpetra/test/test_tpetra_crsgraph.F90 +++ b/src/tpetra/test/test_tpetra_crsgraph.F90 @@ -48,7 +48,7 @@ program test_TpetraCrsGraph ! ADD_SUBTEST_AND_RUN(TpetraCrsGraph_haveGlobalConstants) ! ADD_SUBTEST_AND_RUN(TpetraCrsGraph_computeGlobalConstants) ! ADD_SUBTEST_AND_RUN(TpetraCrsGraph_getGlobalRowCopy) -! ADD_SUBTEST_AND_RUN(TpetraCrsGraph_getgblRowView) +! ADD_SUBTEST_AND_RUN(TpetraCrsGraph_getGlobalRowView) ! call comm%release() @@ -62,16 +62,15 @@ program test_TpetraCrsGraph type(TpetraMap) :: Map type(ParameterList) :: params type(TpetraCrsGraph) :: Graph - integer(local_ordinal_type) :: row, indices(1) - integer(size_type), parameter :: izero=0, ione=1 + integer :: row, indices(1) OUT0("Starting TpetraCrsGraph_ActiveFillLocal!") ! create Map - Map = TpetraMap(TPETRA_GLOBAL_INVALID, ione, comm); TEST_IERR() + Map = TpetraMap(TPETRA_GLOBAL_INVALID, 1, comm); TEST_IERR() params = ParameterList("ANONYMOUS") - Graph = TpetraCrsGraph(Map, Map, izero, TpetraDynamicProfile) + Graph = TpetraCrsGraph(Map, Map, 0_size_type, TpetraDynamicProfile) TEST_ASSERT(Graph%isFillActive()) TEST_ASSERT((.not. Graph%isFillComplete())) @@ -93,7 +92,7 @@ program test_TpetraCrsGraph call params%release() params = ParameterList("ANONYMOUS") - Graph = TpetraCrsGraph(Map, Map, izero, TpetraDynamicProfile) + Graph = TpetraCrsGraph(Map, Map, 0_size_type, TpetraDynamicProfile) TEST_ASSERT(Graph%isFillActive()) TEST_ASSERT((.not. Graph%isFillComplete())) @@ -128,16 +127,15 @@ program test_TpetraCrsGraph type(TpetraMap) :: Map type(ParameterList) :: params type(TpetraCrsGraph) :: Graph - integer(local_ordinal_type) :: row, indices(1) - integer(size_type), parameter :: izero=0, ione=1 + integer :: row, indices(1) OUT0("Starting TpetraCrsGraph_Parameters!") ! create Map - Map = TpetraMap(TPETRA_GLOBAL_INVALID, ione, comm); TEST_IERR() + Map = TpetraMap(TPETRA_GLOBAL_INVALID, 1, comm); TEST_IERR() params = ParameterList("ANONYMOUS") - Graph = TpetraCrsGraph(Map, Map, izero, TpetraDynamicProfile) + Graph = TpetraCrsGraph(Map, Map, 0_size_type, TpetraDynamicProfile) params = Graph%getValidParameters() call Graph%setParameterList(params) @@ -158,11 +156,10 @@ program test_TpetraCrsGraph FORTRILINOS_UNIT_TEST(TpetraCrsGraph_WithColMap) type(TpetraMap) :: rmap, cmap, tmpmap type(TpetraCrsGraph) :: Graph - integer(size_type) :: num_procs, num_local, num_ent_per_row - integer(local_ordinal_type) :: lclrow + integer(size_type) :: num_procs, num_ent_per_row + integer :: num_local, lclrow integer(global_ordinal_type) :: myrowind integer(global_ordinal_type), allocatable :: indices(:) - integer(size_type), parameter :: ione=1 OUT0("Starting TpetraCrsGraph_WithColMap!") @@ -201,7 +198,7 @@ program test_TpetraCrsGraph TEST_EQUALITY(tmpmap%getNodeNumElements(), rmap%getNodeNumElements()) tmpmap = Graph%getColMap() TEST_EQUALITY(tmpmap%getNodeNumElements(), cmap%getNodeNumElements()) - TEST_EQUALITY(Graph%getNumEntriesInGlobalRow(myrowind), ione) + TEST_EQUALITY(Graph%getNumEntriesInGlobalRow(myrowind), 1_size_type) call tmpmap%release() call Graph%release() @@ -216,9 +213,10 @@ program test_TpetraCrsGraph FORTRILINOS_UNIT_TEST(TpetraCrsGraph_TwoArraysESFC) type(TpetraMap) :: rmap, tmpmap type(TpetraCrsGraph) :: Graph - integer(size_type) :: num_procs, num_local + integer(size_type) :: num_procs + integer :: num_local integer(size_type), allocatable :: rowptr(:) - integer(local_ordinal_type), allocatable :: colind(:) + integer, allocatable :: colind(:) integer(global_ordinal_type), allocatable :: indices(:) OUT0("Starting TpetraCrsGraph_TwoArraysESFC!") @@ -261,11 +259,11 @@ program test_TpetraCrsGraph FORTRILINOS_UNIT_TEST(TpetraCrsGraph_SetAllIndices) type(TpetraMap) :: rmap, tmpmap type(TpetraCrsGraph) :: Graph - integer(size_type) :: num_procs, num_local + integer(size_type) :: num_procs + integer :: num_local integer(size_type), allocatable :: rowptr(:) - integer(local_ordinal_type), allocatable :: colind(:) + integer, allocatable :: colind(:) integer(global_ordinal_type), allocatable :: indices(:) - integer(size_type), parameter :: izero=0 OUT0("Starting TpetraCrsGraph_SetAllIndices!") num_procs = comm%getSize() @@ -278,7 +276,7 @@ program test_TpetraCrsGraph rowptr(1:3) = [1, 2, 3] colind(1:2) = [1, 2] - Graph = TpetraCrsGraph(rmap, rmap, izero, TpetraStaticProfile) + Graph = TpetraCrsGraph(rmap, rmap, 0_size_type, TpetraStaticProfile) TEST_NOTHROW(call Graph%setAllIndices(rowptr, colind)) TEST_ASSERT(Graph%hasColMap()) @@ -307,14 +305,14 @@ program test_TpetraCrsGraph type(TpetraMap) :: map type(TpetraCrsGraph) :: Graph type(ParameterList) :: params - integer(size_type) :: num_procs, num_local, nument + integer(size_type) :: kk, num_procs, nument + integer :: num_local integer(size_type), allocatable :: rowptr(:) logical :: sorting_check - integer(size_type), parameter :: izero=0 integer(global_ordinal_type) :: j, jj, jstart, jfinish, firstind, lastind integer(global_ordinal_type), allocatable :: jinds(:) - integer(local_ordinal_type) :: k, kk, kstart, kfinish - integer(local_ordinal_type), allocatable :: kinds(:) + integer :: k, kstart, kfinish + integer, allocatable :: kinds(:) OUT0("Starting TpetraCrsGraph_SortingTests!") @@ -430,8 +428,7 @@ program test_TpetraCrsGraph FORTRILINOS_UNIT_TEST(TpetraCrsGraph_EmptyFillComplete) type(TpetraMap) :: map type(TpetraCrsGraph) :: Graph - integer(size_type) :: num_local - integer(size_type), parameter :: ione=1 + integer :: num_local OUT0("Starting TpetraCrsGraph_EmptyFillComplete!") @@ -441,13 +438,13 @@ program test_TpetraCrsGraph ! create static-profile graph, fill-complete without inserting ! (and therefore, without allocating) - Graph = TpetraCrsGraph(map, ione, TpetraStaticProfile) + Graph = TpetraCrsGraph(map, 1_size_type, TpetraStaticProfile) call Graph%fillComplete() call Graph%release() ! create TpetraDynamic-profile graph, fill-complete without inserting ! (and therefore, without allocating) - Graph = TpetraCrsGraph(map, ione, TpetraDynamicProfile) + Graph = TpetraCrsGraph(map, 1_size_type, TpetraDynamicProfile) call Graph%fillComplete() call Graph%release() @@ -461,12 +458,11 @@ program test_TpetraCrsGraph FORTRILINOS_UNIT_TEST(TpetraCrsGraph_GetEntities) type(TpetraMap) :: rmap, cmap type(TpetraCrsGraph) :: Graph - integer(size_type) :: num_procs, num_local, num_ent_per_row - integer(local_ordinal_type) :: lclrow + integer(size_type) :: num_procs, num_ent_per_row, i_LO + integer :: num_local, lclrow integer(global_ordinal_type) :: myrowind integer(global_ordinal_type), allocatable :: indices(:) - integer(local_ordinal_type) :: i_LO, commsize - integer(local_ordinal_type), parameter :: ione=1 + integer :: commsize OUT0("Starting TpetraCrsGraph_GetEntities!") @@ -502,27 +498,27 @@ program test_TpetraCrsGraph commsize = comm%getSize() i_LO = Graph%getNodeNumRows() - TEST_EQUALITY(i_LO, ione) + TEST_EQUALITY(i_LO, 1_size_type) i_LO = Graph%getNodeNumCols() - TEST_EQUALITY(i_LO, ione) + TEST_EQUALITY(i_LO, 1_size_type) i_LO = Graph%getGlobalNumEntries() - TEST_EQUALITY(i_LO, commsize) + TEST_EQUALITY(i_LO, int(commsize, kind=size_type)) i_LO = Graph%getNodeNumEntries() - TEST_EQUALITY(i_LO, ione) + TEST_EQUALITY(i_LO, 1_size_type) i_LO = Graph%getNodeAllocationSize() - TEST_EQUALITY(i_LO, ione) + TEST_EQUALITY(i_LO, 1_size_type) i_LO = Graph%getNumAllocatedEntriesInGlobalRow(myrowind) - TEST_EQUALITY(i_LO, ione) + TEST_EQUALITY(i_LO, 1_size_type) i_LO = Graph%getNumAllocatedEntriesInLocalRow(lclrow) - TEST_EQUALITY(i_LO, ione) + TEST_EQUALITY(i_LO, 1_size_type) i_LO = Graph%getGlobalNumDiags() - TEST_EQUALITY(i_LO, commsize) + TEST_EQUALITY(i_LO, int(commsize, kind=size_type)) i_LO = Graph%getNodeNumDiags() - TEST_EQUALITY(i_LO, ione) + TEST_EQUALITY(i_LO, 1_size_type) i_LO = Graph%getGlobalMaxNumRowEntries() - TEST_EQUALITY(i_LO, ione) + TEST_EQUALITY(i_LO, 1_size_type) i_LO = Graph%getNodeMaxNumRowEntries() - TEST_EQUALITY(i_LO, ione) + TEST_EQUALITY(i_LO, 1_size_type) call Graph%release() call rmap%release() @@ -532,6 +528,7 @@ program test_TpetraCrsGraph END_FORTRILINOS_UNIT_TEST(TpetraCrsGraph_GetEntities) +#if 0 ! ---------------------------------getComm---------------------------------- ! FORTRILINOS_UNIT_TEST(TpetraCrsGraph_getComm) type(TpetraCrsGraph) :: Obj @@ -898,27 +895,28 @@ program test_TpetraCrsGraph END_FORTRILINOS_UNIT_TEST(TpetraCrsGraph_getGlobalRowCopy) - ! ------------------------------getgblRowView------------------------------- ! - FORTRILINOS_UNIT_TEST(TpetraCrsGraph_getgblRowView) + ! ------------------------------getGlobalRowView------------------------------- ! + FORTRILINOS_UNIT_TEST(TpetraCrsGraph_getGlobalRowView) type(TpetraCrsGraph) :: Obj integer(C_LONG_LONG) :: gblrow integer(C_LONG_LONG), allocatable :: lclcolinds(:) - OUT0("Starting TpetraCrsGraph_getgblRowView!") + OUT0("Starting TpetraCrsGraph_getGlobalRowView!") success = .false. gblrow = 0 !allocate(lclcolinds(:)(0)) !Obj = TpetraCrsGraph(); TEST_IERR() - !call Obj%getgblRowView(gblrow, lclcolinds(:)); TEST_IERR() + !call Obj%getGlobalRowView(gblrow, lclcolinds(:)); TEST_IERR() !deallocate(lclcolinds(:)) !call Obj%release(); TEST_IERR() - write(*,*) 'TpetraCrsGraph_getgblRowView: Test not yet implemented' + write(*,*) 'TpetraCrsGraph_getGlobalRowView: Test not yet implemented' - OUT0("Finished TpetraCrsGraph_getgblRowView!") + OUT0("Finished TpetraCrsGraph_getGlobalRowView!") - END_FORTRILINOS_UNIT_TEST(TpetraCrsGraph_getgblRowView) + END_FORTRILINOS_UNIT_TEST(TpetraCrsGraph_getGlobalRowView) +#endif end program test_TpetraCrsGraph diff --git a/src/tpetra/test/test_tpetra_crsmatrix.F90 b/src/tpetra/test/test_tpetra_crsmatrix.F90 index 8d1331c1..e63f9cdf 100644 --- a/src/tpetra/test/test_tpetra_crsmatrix.F90 +++ b/src/tpetra/test/test_tpetra_crsmatrix.F90 @@ -55,19 +55,16 @@ program test_TpetraCrsMatrix type(TpetraCrsMatrix) :: Mat type(TpetraMultiVector) :: mvrand, mvres character(kind=C_CHAR, len=:), allocatable :: description - integer(size_type) :: num_images, my_image_id - integer(size_type), parameter :: num_local=10, num_vecs=5 - integer(size_type), parameter :: ione=1 - integer(local_ordinal_type) :: irow + integer :: num_images, my_image_id + integer(size_type), parameter :: num_vecs=5 + integer, parameter :: num_local=10 + integer :: irow integer(global_ordinal_type) :: base, gblrow, cols(1) real(mag_type) :: vals(1)=[1.], norms(num_vecs), zeros(num_vecs), fnorm - real(scalar_type), parameter :: zero=0., one=1., negone=-1., two=2., four=4. - real(scalar_type), allocatable :: a1(:), a2(:) - integer(size_type) :: lda OUT0("Starting TpetraCrsMatrix_Basic1") - zeros = zero + zeros = 0.d0 num_images = comm%getSize() my_image_id = comm%getRank() @@ -80,11 +77,11 @@ program test_TpetraCrsMatrix ! create the identity matrix base = num_local * my_image_id; - Mat = TpetraCrsMatrix(Map, ione, TpetraDynamicProfile) + Mat = TpetraCrsMatrix(Map, 1_size_type, TpetraDynamicProfile) do irow = 1, num_local gblrow = base + int(irow, kind=global_ordinal_type) cols(1) = gblrow - vals(1) = one + vals(1) = 1.d0 call Mat%insertGlobalValues(gblrow, cols, vals) end do @@ -142,34 +139,34 @@ program test_TpetraCrsMatrix ! test the action call mvres%randomize(); TEST_IERR() call Mat%apply(mvrand, mvres); TEST_IERR() - call mvres%update(one, mvrand, negone); TEST_IERR() + call mvres%update(1.d0, mvrand, -1.d0); TEST_IERR() call mvres%norm1(norms); TEST_IERR() - TEST_FLOATING_ARRAY_EQUALITY(norms, zero, epsilon(zero)) + TEST_FLOATING_ARRAY_EQUALITY(norms, 0.d0, epsilon(0.d0)) ! Set all diagonal entries to 2 and do again call Mat%resumeFill(); TEST_IERR() - call Mat%setAllToScalar(two); TEST_IERR() + call Mat%setAllToScalar(2.d0); TEST_IERR() call Mat%fillComplete(); TEST_IERR() call mvres%randomize(); TEST_IERR() call Mat%apply(mvrand, mvres); TEST_IERR() - call mvres%update(two, mvrand, negone); TEST_IERR() + call mvres%update(2.d0, mvrand, -1.d0); TEST_IERR() call mvres%norm1(norms); TEST_IERR() - TEST_FLOATING_ARRAY_EQUALITY(norms, zero, epsilon(zero)) + TEST_FLOATING_ARRAY_EQUALITY(norms, 0.d0, epsilon(0.d0)) ! Scale diagonal entries by 2 and do again call Mat%resumeFill(); TEST_IERR() - call Mat%scale(two); TEST_IERR() + call Mat%scale(2.d0); TEST_IERR() call Mat%fillComplete(); TEST_IERR() call mvres%randomize(); TEST_IERR() call Mat%apply(mvrand, mvres); TEST_IERR() - call mvres%update(four, mvrand, negone); TEST_IERR() + call mvres%update(4.d0, mvrand, -1.d0); TEST_IERR() call mvres%norm1(norms); TEST_IERR() - TEST_FLOATING_ARRAY_EQUALITY(norms, zero, epsilon(zero)) + TEST_FLOATING_ARRAY_EQUALITY(norms, 0.d0, epsilon(0.d0)) call Mat%release(); TEST_IERR() call map%release(); TEST_IERR() @@ -187,10 +184,9 @@ program test_TpetraCrsMatrix type(TpetraMap) :: Map, row_map type(TpetraCrsMatrix) :: A type(TpetraMultiVector) :: ones, threes - integer(size_type), parameter :: izero=0, ione=1 - integer(size_type) :: num_images, my_image_id, numindices - integer(local_ordinal_type) :: nnz - real(scalar_type), parameter :: zero=0., one=1., two=2., negthree=-3. + integer :: num_images, my_image_id + integer(size_type) :: numindices + integer :: nnz real(norm_type) :: norms(1) integer(global_ordinal_type) :: gblrow integer(global_ordinal_type), allocatable :: cols(:), xcols(:) @@ -203,12 +199,12 @@ program test_TpetraCrsMatrix if (num_images < 2) return ! create a Map - map = TpetraMap(TPETRA_GLOBAL_INVALID, ione, comm); TEST_IERR() + map = TpetraMap(TPETRA_GLOBAL_INVALID, 1, comm); TEST_IERR() ! create a multivector ones(n,1) - ones = TpetraMultiVector(map, ione, .false.); TEST_IERR() - threes = TpetraMultiVector(map, ione, .false.); TEST_IERR() - call ones%putScalar(one) + ones = TpetraMultiVector(map, 1_size_type, .false.); TEST_IERR() + threes = TpetraMultiVector(map, 1_size_type, .false.); TEST_IERR() + call ones%putScalar(1.d0) ! create the following matrix: ! [2 1 ] @@ -221,24 +217,24 @@ program test_TpetraCrsMatrix ! [ 1 2] ! this matrix has an eigenvalue lambda=3, with eigenvector v = [1 ... 1] - A = TpetraCrsMatrix(map, izero, TpetraDynamicProfile); TEST_IERR() + A = TpetraCrsMatrix(map, 0_size_type, TpetraDynamicProfile); TEST_IERR() gblrow = my_image_id + 1 if (gblrow == 1) then nnz = 2 allocate(cols(nnz)); allocate(vals(nnz)); cols(1:nnz) = [gblrow, gblrow+1] - vals(1:nnz) = [two, one] + vals(1:nnz) = [2.d0, 1.d0] call A%insertGlobalValues(gblrow, cols, vals); TEST_IERR() else if (gblrow == num_images) then nnz = 2; allocate(cols(nnz)); allocate(vals(nnz)); cols(1:nnz) = [gblrow-1, gblrow] - vals(1:nnz) = [one, two] + vals(1:nnz) = [1.d0, 2.d0] call A%insertGlobalValues(gblrow, cols, vals); TEST_IERR() else nnz = 3; allocate(cols(nnz)); allocate(vals(nnz)); - vals = [one, one, one] + vals = [1.d0, 1.d0, 1.d0] cols = [gblrow-1, gblrow, gblrow+1] call A%insertGlobalValues(gblrow, cols, vals); TEST_IERR() end if @@ -270,7 +266,7 @@ program test_TpetraCrsMatrix numindices = int(nnz, kind=size_type) call A%getGlobalRowCopy(gblrow, xcols, xvals, numindices); TEST_IERR() !TEST_ARRAY_EQUALITY(xcols, cols) - !TEST_FLOATING_ARRAY_EQUALITY(xvals, vals, epsilon(zero)) + !TEST_FLOATING_ARRAY_EQUALITY(xvals, vals, epsilon(0.d0)) deallocate(xcols); deallocate(xvals) ! test the action @@ -278,9 +274,9 @@ program test_TpetraCrsMatrix call A%apply(ones, threes); TEST_IERR() ! now, threes should be 3*ones - call threes%update(negthree, ones, one) + call threes%update(-3.d0, ones, 1.d0) call threes%norm1(norms) - TEST_FLOATING_ARRAY_EQUALITY(norms, zero, epsilon(zero)) + TEST_FLOATING_ARRAY_EQUALITY(norms, 0.d0, epsilon(0.d0)) call ones%release() call threes%release() @@ -298,19 +294,18 @@ program test_TpetraCrsMatrix type(TpetraMap) :: Map type(TpetraCrsMatrix) :: Mat type(TpetraMultiVector) :: X, Y, Z - integer(size_type), parameter :: numvecs=1 - real(scalar_type), parameter :: zero=0., one=1. + integer(size_type), parameter ::numvecs=1 real(scalar_type) :: alpha, beta - integer(size_type) :: my_image_id + integer :: my_image_id integer(global_ordinal_type) :: gblrow, base, cols(1), i - real(scalar_type) :: ones(1)=[one], normz(numvecs), normy(numvecs) + real(scalar_type) :: ones(1)=[1.d0], normz(numvecs), normy(numvecs) OUT0("Starting TpetraCrsMatrix_AlphaBetaMultiply") my_image_id = comm%getRank() ! create a Map - map = TpetraMap(TPETRA_GLOBAL_INVALID, 3_size_type, comm); TEST_IERR() + map = TpetraMap(TPETRA_GLOBAL_INVALID, 3, comm); TEST_IERR() ! Create the identity matrix, three rows per proc base = 3 * my_image_id; @@ -333,14 +328,14 @@ program test_TpetraCrsMatrix call Y%randomize() ! Z = alpha*X + beta*Y - call Z%update(alpha, X, beta, Y, zero) + call Z%update(alpha, X, beta, Y, 0.d0) ! test the action: Y = alpha*I*X + beta*Y = alpha*X + beta*Y = Z call Mat%apply(X, Y, TEUCHOSNO_TRANS, alpha, beta) ! call Z%norm1(normz) call Y%norm1(normy) - TEST_FLOATING_ARRAY_EQUALITY(normy, normz, epsilon(zero)) + TEST_FLOATING_ARRAY_EQUALITY(normy, normz, epsilon(0.d0)) call Z%release() call Y%release() @@ -356,18 +351,16 @@ program test_TpetraCrsMatrix type(TpetraMap) :: Map type(ParameterList) :: params type(TpetraCrsMatrix) :: Mat - integer(size_type), parameter :: izero=0, ione=1 - integer(local_ordinal_type) :: lclrow, numvalid + integer :: lclrow, numvalid integer(global_ordinal_type) :: row, cols(1) - real(scalar_type), parameter :: zero=0. - real(scalar_type) :: vals(1), zeros(1)=[zero] + real(scalar_type) :: vals(1), zeros(1)=[0.d0] OUT0("Starting TpetraCrsMatrix_ActiveFillGlobal") ! create Map - map = TpetraMap(TPETRA_GLOBAL_INVALID, ione, comm); TEST_IERR() + map = TpetraMap(TPETRA_GLOBAL_INVALID, 1, comm); TEST_IERR() - Mat = TpetraCrsMatrix(map, map, izero, TpetraDynamicProfile); TEST_IERR() + Mat = TpetraCrsMatrix(map, map, 0_size_type, TpetraDynamicProfile); TEST_IERR() TEST_ASSERT(Mat%isFillActive()) TEST_ASSERT((.not. Mat%isFillComplete())) lclrow = 1 @@ -394,20 +387,20 @@ program test_TpetraCrsMatrix numvalid = Mat%sumIntoGlobalValues(row, cols, vals); TEST_IERR() TEST_ASSERT(numvalid==TPETRA_GLOBAL_INVALID) - TEST_THROW(call Mat%setAllToScalar(zero)) - TEST_THROW(call Mat%scale(zero)) + TEST_THROW(call Mat%setAllToScalar(0.d0)) + TEST_THROW(call Mat%scale(0.d0)) TEST_THROW(call Mat%globalAssemble()) TEST_THROW(call Mat%fillComplete()) call params%release() call Mat%release() - Mat = TpetraCrsMatrix(map, map, izero, TpetraDynamicProfile); TEST_IERR() + Mat = TpetraCrsMatrix(map, map, 0_size_type, TpetraDynamicProfile); TEST_IERR() TEST_ASSERT(Mat%isFillActive()) TEST_ASSERT((.not. Mat%isFillComplete())) lclrow = 1 row = map%getGlobalElement(lclrow) - cols(1) = row; vals(1) = zero; + cols(1) = row; vals(1) = 0.d0; ! FIXME: If a mistake is made, and cols above is just set to 1: ! cols(1) = 1 ! FIXME: then the call to fillComplete below hangs indefinitely @@ -426,8 +419,8 @@ program test_TpetraCrsMatrix !TEST_NOTHROW(call Mat%insertGlobalValues(row, cols, vals)) TEST_NOTHROW(numvalid = Mat%replaceGlobalValues(row, cols, vals)) TEST_NOTHROW(numvalid = Mat%sumIntoGlobalValues(row, cols, vals)) - TEST_NOTHROW(call Mat%setAllToScalar(zero)) - TEST_NOTHROW(call Mat%scale(zero)) + TEST_NOTHROW(call Mat%setAllToScalar(0.d0)) + TEST_NOTHROW(call Mat%scale(0.d0)) TEST_NOTHROW(call Mat%globalAssemble()) TEST_NOTHROW(call Mat%fillComplete()) @@ -449,17 +442,15 @@ program test_TpetraCrsMatrix type(TpetraMap) :: Map type(ParameterList) :: params type(TpetraCrsMatrix) :: Mat - integer(size_type), parameter :: izero=0, ione=1 - integer(local_ordinal_type) :: row, cols(1), numvalid - real(scalar_type), parameter :: zero=0. - real(scalar_type) :: vals(1), zeros(1)=[zero] + integer :: row, cols(1), numvalid + real(scalar_type) :: vals(1), zeros(1)=[0.d0] OUT0("Starting TpetraCrsMatrix_ActiveFillLocal") ! create Map - map = TpetraMap(TPETRA_GLOBAL_INVALID, ione, comm); TEST_IERR() + map = TpetraMap(TPETRA_GLOBAL_INVALID, 1, comm); TEST_IERR() - Mat = TpetraCrsMatrix(map, map, izero, TpetraDynamicProfile); TEST_IERR() + Mat = TpetraCrsMatrix(map, map, 0, TpetraDynamicProfile); TEST_IERR() TEST_ASSERT(Mat%isFillActive()) TEST_ASSERT((.not. Mat%isFillComplete())) row = 1; cols(1) = 1; vals(1) = 0. @@ -484,22 +475,22 @@ program test_TpetraCrsMatrix numvalid = Mat%sumIntoLocalValues(lcrow, cols, vals); TEST_IERR() TEST_ASSERT(numvalid==TPETRA_GLOBAL_INVALID) - TEST_THROW(call Mat%setAllToScalar(zero)) - TEST_THROW(call Mat%scale(zero)) + TEST_THROW(call Mat%setAllToScalar(0.d0)) + TEST_THROW(call Mat%scale(0.d0)) TEST_THROW(call Mat%globalAssemble()) TEST_THROW(call Mat%fillComplete()) call params%release() call Mat%release() - Mat = TpetraCrsMatrix(map, map, izero, TpetraDynamicProfile); TEST_IERR() + Mat = TpetraCrsMatrix(map, map, 0, TpetraDynamicProfile); TEST_IERR() TEST_ASSERT(Mat%isFillActive()) TEST_ASSERT((.not. Mat%isFillComplete())) - row = 1; cols(1) = 1; vals(1) = zero; + row = 1; cols(1) = 1; vals(1) = 0.d0; call Mat%insertLocalValues(row, cols, vals); TEST_IERR() - params = ParameterList("ANONYMOUS"); TEST_IERR() - call params%set("Optimize Storage", .false.); TEST_IERR() + params = ParameterList("ANONOMOUS"); TEST_IERR() + !call params%set("Optimize Storage", .false.); TEST_IERR() ! FIXME: boolean parameters call Mat%fillComplete(params); TEST_IERR() TEST_ASSERT((.not. Mat%isFillActive())) TEST_ASSERT(Mat%isFillComplete()) @@ -512,8 +503,8 @@ program test_TpetraCrsMatrix TEST_NOTHROW(call Mat%sumIntoLocalValues(row, cols, vals)) ! FIXME: The following should NOT set ierr/=0 but does - TEST_NOTHROW(call Mat%setAllToScalar(zero)) - TEST_NOTHROW(call Mat%scale(zero)) + TEST_NOTHROW(call Mat%setAllToScalar(0.d0)) + TEST_NOTHROW(call Mat%scale(0.d0)) TEST_NOTHROW(call Mat%globalAssemble()) TEST_NOTHROW(call Mat%fillComplete()) @@ -629,8 +620,8 @@ program test_TpetraCrsMatrix ! ----------------------------getLocalRowViewRaw---------------------------- ! FORTRILINOS_UNIT_TEST(TpetraCrsMatrix_getLocalRowViewRaw) type(TpetraCrsMatrix) :: Obj - integer(local_ordinal_type) :: lclrow - integer(local_ordinal_type) :: nument + integer :: lclrow + integer :: nument type(C_PTR) :: lclcolinds type(C_PTR) :: vals OUT0("Starting TpetraCrsMatrix_getLocalRowViewRaw") diff --git a/src/tpetra/test/test_tpetra_import_export.F90 b/src/tpetra/test/test_tpetra_import_export.F90 index d7703db1..93c46a99 100644 --- a/src/tpetra/test/test_tpetra_import_export.F90 +++ b/src/tpetra/test/test_tpetra_import_export.F90 @@ -24,6 +24,7 @@ program test_TpetraImportExport ADD_SUBTEST_AND_RUN(TpetraImportExport_Basic) ADD_SUBTEST_AND_RUN(TpetraImportExport_GetNeighborsForward) + !ADD_SUBTEST_AND_RUN(TpetraImportExport_AbsMax) !ADD_SUBTEST_AND_RUN(TpetraImport_isLocallyComplete) !ADD_SUBTEST_AND_RUN(TpetraImport_createRemoteOnlyImport) @@ -38,14 +39,13 @@ program test_TpetraImportExport FORTRILINOS_UNIT_TEST(TpetraImportExport_Basic) type(TpetraMap) :: src, tgt type(TpetraImport) :: importer - integer(size_type), parameter :: ten=10, five=5 integer(size_type) :: same, permute, remote, expected_sum, the_sum OUT0("Starting TpetraImportExport_Basic!") ! create Maps - src = TpetraMap(TPETRA_GLOBAL_INVALID, ten, comm) - tgt = TpetraMap(TPETRA_GLOBAL_INVALID, five, comm) + src = TpetraMap(TPETRA_GLOBAL_INVALID, 10, comm) + tgt = TpetraMap(TPETRA_GLOBAL_INVALID, 5, comm) ! create Import object importer = TpetraImport(src, tgt) @@ -71,11 +71,9 @@ program test_TpetraImportExport type(TpetraMultiVector) :: mine_parent, neigh_parent real(scalar_type), allocatable :: val(:) real(scalar_type), pointer :: a(:) - real(scalar_type), parameter :: zero=0 - integer(size_type), parameter :: ten=10, five=5 - integer(size_type) :: num_images, my_image_id, num_local, num_vecs + integer(size_type) :: num_images, my_image_id, num_vecs integer(size_type) :: tnum, j, n - integer(local_ordinal_type) :: lclrow + integer :: lclrow, num_local integer(global_ordinal_type), allocatable :: neighbors(:), cols(:) OUT0("Starting TpetraImportExport_GetNeighborsForward!") @@ -185,15 +183,15 @@ program test_TpetraImportExport end do ! export values, test - call mv_mine%putScalar(zero) + call mv_mine%putScalar(0d0) call mv_mine%doExport(mv_with_neighbors, exporter, TpetraADD) do j = 1, num_vecs a => mv_mine%getData(j) if (my_image_id == 0 .or. my_image_id == num_images-1) then ! contribution from me and one neighbor: double original value - val(1) = real(2.0*(my_image_id+j*num_images), kind=scalar_type) + val(1) = real(2*(my_image_id+j*num_images), kind=scalar_type) else - val(1) = real(3.0*(my_image_id+j*num_images), kind=scalar_type) + val(1) = real(3*(my_image_id+j*num_images), kind=scalar_type) end if TEST_FLOATING_EQUALITY(a(1), val(1), epsilon(val(1))) end do @@ -215,6 +213,7 @@ program test_TpetraImportExport END_FORTRILINOS_UNIT_TEST(TpetraImportExport_GetNeighborsForward) +#if 0 ! --------------------------------- AbsMax --------------------------------- ! FORTRILINOS_UNIT_TEST(TpetraImportExport_AbsMax) type(TpetraMap) :: smap, dmap @@ -223,7 +222,7 @@ program test_TpetraImportExport type(TpetraMultiVector) :: svec, dvec integer(size_type) :: num_images real(scalar_type), pointer :: a(:) - integer(local_ordinal_type) :: lclrow + integer :: lclrow integer(global_ordinal_type) :: my_only_gid, cols(2) integer(size_type), parameter :: one=1 integer(global_ordinal_type), parameter :: twog=2 @@ -305,5 +304,6 @@ program test_TpetraImportExport OUT0("Finished TpetraImport_createRemoteOnlyImport!") END_FORTRILINOS_UNIT_TEST(TpetraImport_createRemoteOnlyImport) +#endif end program test_TpetraImportExport diff --git a/src/tpetra/test/test_tpetra_map.F90 b/src/tpetra/test/test_tpetra_map.F90 index acc29c18..013a5eb0 100644 --- a/src/tpetra/test/test_tpetra_map.F90 +++ b/src/tpetra/test/test_tpetra_map.F90 @@ -87,7 +87,7 @@ program test_TpetraMap integer(global_ordinal_type) :: num_global num_global = 4*comm%getSize() Obj = TpetraMap(num_global, comm); TEST_IERR() - TEST_EQUALITY(Obj%getNodeNumElements(), int(4, kind=size_type)) + TEST_EQUALITY(Obj%getNodeNumElements(), 4) call Obj%release(); TEST_IERR() END_FORTRILINOS_UNIT_TEST(TpetraMap_getNodeNumElements) @@ -97,7 +97,7 @@ program test_TpetraMap integer(global_ordinal_type) :: num_global num_global = 4*comm%getSize() Obj = TpetraMap(num_global, comm); TEST_IERR() - TEST_EQUALITY(Obj%getMinLocalIndex(), int(1, kind=local_ordinal_type)) + TEST_EQUALITY(Obj%getMinLocalIndex(), 1) call Obj%release(); TEST_IERR() END_FORTRILINOS_UNIT_TEST(TpetraMap_getMinLocalIndex) @@ -107,14 +107,14 @@ program test_TpetraMap integer(global_ordinal_type) :: num_global num_global = 4*comm%getSize() Obj = TpetraMap(num_global, comm); TEST_IERR() - TEST_EQUALITY(Obj%getMaxLocalIndex(), int(4, kind=local_ordinal_type)) + TEST_EQUALITY(Obj%getMaxLocalIndex(), 4) call Obj%release(); TEST_IERR() END_FORTRILINOS_UNIT_TEST(TpetraMap_getMaxLocalIndex) ! -----------------------------getMinGlobalIndex------------------------------ ! FORTRILINOS_UNIT_TEST(TpetraMap_getMinGlobalIndex) type(TpetraMap) :: Obj - integer(C_LONG_LONG) :: expected + integer(global_ordinal_type) :: expected integer(global_ordinal_type) :: num_global num_global = 4*comm%getSize() Obj = TpetraMap(num_global, comm); TEST_IERR() @@ -126,7 +126,7 @@ program test_TpetraMap ! -----------------------------getMaxGlobalIndex------------------------------ ! FORTRILINOS_UNIT_TEST(TpetraMap_getMaxGlobalIndex) type(TpetraMap) :: Obj - integer(C_LONG_LONG) :: expected + integer(global_ordinal_type) :: expected integer(global_ordinal_type) :: num_global num_global = 4*comm%getSize() Obj = TpetraMap(num_global, comm); TEST_IERR() @@ -159,7 +159,7 @@ program test_TpetraMap ! ------------------------------getLocalElement------------------------------- ! FORTRILINOS_UNIT_TEST(TpetraMap_getLocalElement) type(TpetraMap) :: Obj - integer(C_LONG_LONG) :: globalindex + integer(global_ordinal_type) :: globalindex integer(global_ordinal_type) :: num_global num_global = 4*comm%getSize() Obj = TpetraMap(num_global, comm); TEST_IERR() @@ -174,7 +174,7 @@ program test_TpetraMap FORTRILINOS_UNIT_TEST(TpetraMap_getGlobalElement) type(TpetraMap) :: Obj integer(C_INT) :: localindex - integer(C_LONG_LONG) :: expected + integer(global_ordinal_type) :: expected integer(global_ordinal_type) :: num_global num_global = 4*comm%getSize() Obj = TpetraMap(num_global, comm); TEST_IERR() @@ -215,7 +215,7 @@ program test_TpetraMap ! ----------------------------isNodeGlobalElement----------------------------- ! FORTRILINOS_UNIT_TEST(TpetraMap_isNodeGlobalElement) type(TpetraMap) :: Obj - integer(C_LONG_LONG) :: globalindex + integer(global_ordinal_type) :: globalindex integer(global_ordinal_type) :: num_global num_global = 4*comm%getSize() Obj = TpetraMap(num_global, comm); TEST_IERR() @@ -323,7 +323,7 @@ program test_TpetraMap ! ----------------------------------isSameAs---------------------------------- ! FORTRILINOS_UNIT_TEST(TpetraMap_isSameAs) type(TpetraMap) :: Obj1, Obj2 - integer(size_type) :: num_local + integer :: num_local integer(global_ordinal_type) :: num_global, elements(4) integer :: k num_global = 4*comm%getSize() @@ -357,7 +357,7 @@ program test_TpetraMap ! -------------------------------locallySameAs-------------------------------- ! FORTRILINOS_UNIT_TEST(TpetraMap_locallySameAs) type(TpetraMap) :: Obj1, Obj2 - integer(size_type) :: num_local + integer :: num_local integer(global_ordinal_type) :: num_global, elements(4) integer :: k num_global = 4*comm%getSize() diff --git a/src/tpetra/test/test_tpetra_multivector.F90 b/src/tpetra/test/test_tpetra_multivector.F90 index c4a8f62c..c9ab3a20 100644 --- a/src/tpetra/test/test_tpetra_multivector.F90 +++ b/src/tpetra/test/test_tpetra_multivector.F90 @@ -59,14 +59,14 @@ program test_TpetraMultiVector integer :: i type(TpetraMap) :: map type(TpetraMultiVector) :: A, B, A2, C - integer(size_type), parameter :: num_vecs=2, num_local=2, LDA=2 - integer(local_ordinal_type) :: lclrow + integer(size_type), parameter :: num_vecs=2, LDA=2 + integer, parameter :: num_local=2 + integer :: lclrow logical :: zeroout - real(scalar_type), parameter :: zero=0., one=1., two=2., four=4., negone=-1. real(scalar_type) :: norms(num_vecs), zeros(num_vecs), values(6) integer(global_ordinal_type) :: gblrow, num_global - zeros = zero + zeros = 0.d0 map = TpetraMap(TPETRA_GLOBAL_INVALID, num_local, comm); TEST_IERR() @@ -79,7 +79,7 @@ program test_TpetraMultiVector ! has values .5 of a multivector B constructed from the second ! then 2*A - B = 0 ! we test both scale(), both update(), and norm() - values = [one, one, two, two, four, four] + values = [1.d0, 1.d0, 2.d0, 2.d0, 4.d0, 4.d0] ! TODO: Multivec create to take array, not ArrayView A = TpetraMultiVector(map, values(1:4), LDA, num_vecs); TEST_IERR() @@ -98,18 +98,18 @@ program test_TpetraMultiVector ! scale it by 2 in situ ! check that it equals B: subtraction in situ A2 = TpetraMultiVector(A, TeuchosCopy); TEST_IERR() - call A2%scale(two) - call A2%update(negone, B, one) + call A2%scale(2.d0) + call A2%update(-1.d0, B, 1.0d0) call A2%norm1(norms) - TEST_FLOATING_ARRAY_EQUALITY(norms, zeros, epsilon(zero)) + TEST_FLOATING_ARRAY_EQUALITY(norms, zeros, epsilon(0.d0)) call A2%release() ! set A2 = A ! check that it equals B: scale, subtraction in situ A2 = TpetraMultiVector(A, TeuchosCopy); TEST_IERR() - call A2%update(negone, B, two) + call A2%update(-1.d0, B, 2.d0) call A2%norm1(norms) - TEST_FLOATING_ARRAY_EQUALITY(norms, zeros, epsilon(zero)) + TEST_FLOATING_ARRAY_EQUALITY(norms, zeros, epsilon(0.d0)) call A2%release() ! set C random @@ -117,19 +117,19 @@ program test_TpetraMultiVector zeroout = .false. C = TpetraMultiVector(map, num_vecs, zeroout); TEST_IERR() call C%randomize() - call C%update(negone, B, two, A, zero) + call C%update(-1.d0, B, 2.d0, A, 0.d0) call C%norm1(norms) - TEST_FLOATING_ARRAY_EQUALITY(norms, zeros, epsilon(zero)) + TEST_FLOATING_ARRAY_EQUALITY(norms, zeros, epsilon(0.d0)) call C%release() ! set C random ! scale it ex-situ ! check that it equals B: subtraction in situ C = TpetraMultiVector(map, num_vecs, zeroout); TEST_IERR() - call C%scale(two, A) - call C%update(one, B, negone) + call C%scale(2.d0, A) + call C%update(1.0d0, B, -1.d0) call C%norm1(norms) - TEST_FLOATING_ARRAY_EQUALITY(norms, zeros, epsilon(zero)) + TEST_FLOATING_ARRAY_EQUALITY(norms, zeros, epsilon(0.d0)) call C%release() ! Clean up @@ -143,7 +143,8 @@ program test_TpetraMultiVector FORTRILINOS_UNIT_TEST(TpetraMultiVector_CountNormInf) type(TpetraMap) :: map type(TpetraMultiVector) :: Vec - integer(size_type), parameter :: num_vecs=3, num_local=2, LDA=2 + integer(size_type), parameter :: num_vecs=3, LDA=2 + integer, parameter :: num_local=2 real(scalar_type) :: values(num_vecs*num_local), answer(num_vecs), norms(num_vecs) OUT0("Starting CountNormInf") @@ -175,8 +176,8 @@ program test_TpetraMultiVector FORTRILINOS_UNIT_TEST(TpetraMultiVector_Norm2) type(TpetraMap) :: map type(TpetraMultiVector) :: Vec - real(scalar_type), parameter :: zero=0. - integer(size_type), parameter :: num_vecs=7, num_local=13 + integer(size_type), parameter :: num_vecs=7 + integer, parameter :: num_local=13 real(scalar_type) :: norms_rand(num_vecs), norms_zero(num_vecs) OUT0("Starting Norm2") @@ -191,14 +192,14 @@ program test_TpetraMultiVector call Vec%norm2(norms_rand) ! Zero the vector - call Vec%putScalar(zero) + call Vec%putScalar(0.d0) ! Take the norms, they should be zero call Vec%norm2(norms_zero) ! Check the answers - TEST_FLOATING_ARRAY_INEQUALITY(norms_rand, zero, epsilon(zero)) - TEST_FLOATING_ARRAY_EQUALITY(norms_zero, zero, epsilon(zero)) + TEST_FLOATING_ARRAY_INEQUALITY(norms_rand, 0.d0, epsilon(0.d0)) + TEST_FLOATING_ARRAY_EQUALITY(norms_zero, 0.d0, epsilon(0.d0)) call Vec%release() call map%release() @@ -211,9 +212,9 @@ program test_TpetraMultiVector FORTRILINOS_UNIT_TEST(TpetraMultiVector_Reciprocal) type(TpetraMap) :: map type(TpetraMultiVector) :: A, B - integer(size_type), parameter :: num_vecs=2, num_local=10 + integer(size_type), parameter :: num_vecs=2 + integer, parameter :: num_local=10 real(scalar_type) :: dots(num_vecs) - real(scalar_type), parameter :: one=1., five=5. OUT0("Starting Reciprocal") @@ -222,14 +223,14 @@ program test_TpetraMultiVector A = TpetraMultiVector(map, num_vecs); TEST_IERR() B = TpetraMultiVector(map, num_vecs); TEST_IERR() - call A%putScalar(five); TEST_IERR() + call A%putScalar(5.0d0); TEST_IERR() call B%reciprocal(A); TEST_IERR() - ! Take the dots, they should one + ! Take the dots, they should 1.0d0 call A%dot(B, dots) ! Check the answers - TEST_FLOATING_ARRAY_EQUALITY(dots, one*num_local*comm%getSize(), epsilon(one)) + TEST_FLOATING_ARRAY_EQUALITY(dots, 1.0d0*num_local*comm%getSize(), epsilon(1.0d0)) call A%release() call B%release() @@ -273,8 +274,8 @@ program test_TpetraMultiVector integer :: i type(TpetraMap) :: map type(TpetraMultiVector) :: A, B, A2 - integer(size_type), parameter :: num_vecs=2, num_local=10 - real(scalar_type), parameter :: zero=0., one=1., negone=-1. + integer(size_type), parameter :: num_vecs=2 + integer, parameter :: num_local=10 real(scalar_type) :: norms(num_vecs) OUT0("Starting Abs") @@ -282,16 +283,16 @@ program test_TpetraMultiVector A = TpetraMultiVector(map, num_vecs); TEST_IERR() B = TpetraMultiVector(map, num_vecs); TEST_IERR() - call A%putScalar(negone); TEST_IERR() + call A%putScalar(-1.d0); TEST_IERR() call A%abs(B) ! set A2 = A ! scale it by 2 in situ ! check that it equals B: subtraction in situ A2 = TpetraMultiVector(A, TeuchosCopy); TEST_IERR() - call A2%update(one, B, one) + call A2%update(1.0d0, B, 1.0d0) call A2%norm1(norms) - TEST_FLOATING_ARRAY_EQUALITY(norms, zero, epsilon(zero)) + TEST_FLOATING_ARRAY_EQUALITY(norms, 0.d0, epsilon(0.d0)) call A2%release() call B%release() @@ -307,7 +308,8 @@ program test_TpetraMultiVector type(TpetraMap) :: map type(TpetraMultiVector) :: Vec character(kind=C_CHAR, len=:), allocatable :: description - integer(size_type), parameter :: num_vecs=2, num_local=10 + integer(size_type), parameter :: num_vecs=2 + integer, parameter :: num_local=10 integer(global_ordinal_type) :: num_global map = TpetraMap(TPETRA_GLOBAL_INVALID, num_local, comm); TEST_IERR() Vec = TpetraMultiVector(map, num_vecs) @@ -321,7 +323,8 @@ program test_TpetraMultiVector FORTRILINOS_UNIT_TEST(TpetraMultiVector_MeanValue) type(TpetraMap) :: map type(TpetraMultiVector) :: Vec - integer(size_type), parameter :: num_vecs=2, num_local=2, LDA=2 + integer(size_type), parameter :: num_vecs=2, LDA=2 + integer, parameter :: num_local=2 real(scalar_type) :: values(4), means(num_vecs), answer(num_vecs) OUT0("Starting MeanValue") @@ -352,26 +355,25 @@ program test_TpetraMultiVector type(TpetraMap) :: map2n, map3n, lmap2, lmap3 type(TpetraMultiVector) :: mv3nx2, mv3nx3, mv2x2, mv2x3, mv3x2, mv3x3 real(scalar_type), parameter :: S0=0., S1=1. - integer(size_type), parameter :: n2=2, n3=3 integer(int_type) :: num_images integer(global_size_type) :: num_global real(scalar_type) :: check(9) OUT0("Starting Multiply") - map2n = TpetraMap(TPETRA_GLOBAL_INVALID, n2, comm); TEST_IERR() - map3n = TpetraMap(TPETRA_GLOBAL_INVALID, n3, comm); TEST_IERR() + map2n = TpetraMap(TPETRA_GLOBAL_INVALID, 2, comm); TEST_IERR() + map3n = TpetraMap(TPETRA_GLOBAL_INVALID, 3, comm); TEST_IERR() - lmap2 = TpetraMap(n2, comm, TpetraLocallyReplicated); TEST_IERR() - lmap3 = TpetraMap(n3, comm, TpetraLocallyReplicated); TEST_IERR() + lmap2 = TpetraMap(2_size_type, comm, TpetraLocallyReplicated); TEST_IERR() + lmap3 = TpetraMap(3_size_type, comm, TpetraLocallyReplicated); TEST_IERR() - mv3nx2 = TpetraMultiVector(map3n, n2) - mv3nx3 = TpetraMultiVector(map3n, n3) + mv3nx2 = TpetraMultiVector(map3n, 2_size_type) + mv3nx3 = TpetraMultiVector(map3n, 3_size_type) - mv2x2 = TpetraMultiVector(lmap2, n2) - mv2x3 = TpetraMultiVector(lmap2, n3) - mv3x2 = TpetraMultiVector(lmap3, n2) - mv3x3 = TpetraMultiVector(lmap3, n3) + mv2x2 = TpetraMultiVector(lmap2, 2_size_type) + mv2x3 = TpetraMultiVector(lmap2, 3_size_type) + mv3x2 = TpetraMultiVector(lmap3, 2_size_type) + mv3x3 = TpetraMultiVector(lmap3, 3_size_type) num_images = comm%getSize() check = 3 * num_images @@ -404,14 +406,16 @@ program test_TpetraMultiVector FORTRILINOS_UNIT_TEST(TpetraMultiVector_Basic) type(TpetraMap) :: map type(TpetraMultiVector) :: Vec - integer(size_type), parameter :: num_vecs=12, num_local=2 + integer(size_type), parameter :: num_vecs=12 + integer, parameter :: num_local=2 map = TpetraMap(TPETRA_GLOBAL_INVALID, num_local, comm); TEST_IERR() Vec = TpetraMultiVector(map, num_vecs); TEST_IERR() TEST_EQUALITY(Vec%getNumVectors(), num_vecs) TEST_EQUALITY(Vec%getLocalLength(), num_local) - TEST_EQUALITY(Vec%getGlobalLength(), num_local*comm%getSize()) - TEST_EQUALITY(Vec%getStride(), num_local) + TEST_EQUALITY(Vec%getGlobalLength(), + int(num_local*comm%getSize(), size_type)) + TEST_EQUALITY(Vec%getStride(), int(num_local, size_type)) TEST_ASSERT(Vec%isConstantStride()) call Vec%release(); TEST_IERR() @@ -423,13 +427,13 @@ program test_TpetraMultiVector type(TpetraMap) :: map type(TpetraMultiVector) :: Vec integer(global_size_type) :: num_global - integer(size_type), parameter :: num_vecs=1, num_local=2 - real(scalar_type), parameter :: two=2. + integer(size_type), parameter :: num_vecs=1 + integer, parameter :: num_local=2 OUT0("Starting Reduce") num_global = num_local * comm%getSize() map = TpetraMap(num_global, comm, TpetraLocallyReplicated); TEST_IERR() Vec = TpetraMultiVector(map, num_vecs); TEST_IERR() - call Vec%putScalar(two); TEST_IERR() + call Vec%putScalar(2.d0); TEST_IERR() call Vec%reduce(); TEST_IERR() call Vec%release(); TEST_IERR() call map%release(); TEST_IERR() @@ -442,10 +446,10 @@ program test_TpetraMultiVector type(TpetraMap) :: map type(TpetraMultiVector) :: Vec, OneV integer(size_type) :: col - integer(size_type), parameter :: num_vecs=2, num_local=4 - integer(local_ordinal_type) :: lclrow + integer(size_type), parameter :: num_vecs=2 + integer, parameter :: num_local=4 + integer :: lclrow real(scalar_type) :: value, expected, dots(num_vecs) - real(scalar_type), parameter :: one=1. integer(global_ordinal_type) :: gblrow, num_global OUT0("Starting replaceGlobalValue") num_global = num_local * comm%getSize() @@ -453,7 +457,7 @@ program test_TpetraMultiVector Vec = TpetraMultiVector(map, num_vecs); TEST_IERR() OneV = TpetraMultiVector(map, num_vecs); TEST_IERR() - call OneV%putScalar(one); TEST_IERR() + call OneV%putScalar(1.0d0); TEST_IERR() do lclrow = 1, num_local gblrow = map%getGlobalElement(lclrow) @@ -464,7 +468,7 @@ program test_TpetraMultiVector end do call Vec%dot(OneV, dots) - expected = real(num_global * (num_global + 1) / 2., kind=scalar_type) + expected = real(num_global * (num_global + 1) / 2, kind=scalar_type) TEST_FLOATING_EQUALITY(dots(1), dots(2), epsilon(dots(2))) TEST_FLOATING_EQUALITY(expected, dots(1), epsilon(dots(2))) @@ -481,16 +485,16 @@ program test_TpetraMultiVector type(TpetraMap) :: map type(TpetraMultiVector) :: Vec, OneV integer(size_type) :: col - integer(local_ordinal_type) :: lclrow - integer(size_type), parameter :: num_vecs=2, num_local=4 + integer :: lclrow + integer(size_type), parameter :: num_vecs=2 + integer, parameter :: num_local=4 real(scalar_type) :: value, dots(num_vecs), expected - real(scalar_type), parameter :: one=1. OUT0("Starting ReplaceLocalValue") map = TpetraMap(TPETRA_GLOBAL_INVALID, num_local, comm); TEST_IERR() Vec = TpetraMultiVector(map, num_vecs); TEST_IERR() OneV = TpetraMultiVector(map, num_vecs); TEST_IERR() - call OneV%putScalar(one) + call OneV%putScalar(1.0d0) do lclrow = 1, num_local value = real(lclrow, kind=scalar_type) @@ -500,7 +504,7 @@ program test_TpetraMultiVector end do call Vec%dot(OneV, dots) - expected = real(comm%getSize() * (num_local * (num_local + 1)) / 2., kind=scalar_type) + expected = real(comm%getSize() * (num_local * (num_local + 1)) / 2, kind=scalar_type) TEST_FLOATING_EQUALITY(dots(1), dots(2), epsilon(dots(2))) TEST_FLOATING_EQUALITY(expected, dots(1), epsilon(dots(2))) @@ -518,19 +522,19 @@ program test_TpetraMultiVector type(TpetraMultiVector) :: Vec integer(size_type) :: lda real(scalar_type), allocatable :: a(:) - integer(size_type), parameter :: num_vecs=2, num_local=4 - real(scalar_type), parameter :: one=1. + integer(size_type), parameter :: num_vecs=2 + integer, parameter :: num_local=4 OUT0("Starting Get1dCopy") map = TpetraMap(TPETRA_GLOBAL_INVALID, num_local, comm); TEST_IERR() Vec = TpetraMultiVector(map, num_vecs); TEST_IERR() - call Vec%putScalar(one); TEST_IERR() + call Vec%putScalar(1.0d0); TEST_IERR() allocate(a(num_vecs*num_local*comm%getSize())) a = 0. lda = num_local*comm%getSize() call Vec%Get1dCopy(a, lda); TEST_IERR() call Vec%release(); TEST_IERR() - TEST_FLOATING_ARRAY_EQUALITY(a, one, epsilon(one)) + TEST_FLOATING_ARRAY_EQUALITY(a, 1.0d0, epsilon(1.0d0)) deallocate(a) call map%release(); TEST_IERR() @@ -541,6 +545,7 @@ program test_TpetraMultiVector END_FORTRILINOS_UNIT_TEST(TpetraMultiVector_Get1dCopy) +#if 0 ! ----------------------------offsetViewNonConst---------------------------- ! FORTRILINOS_UNIT_TEST(TpetraMultiVector_offsetViewNonConst) type(TpetraMultiVector) :: Obj @@ -625,7 +630,7 @@ program test_TpetraMultiVector write(*,*) 'getCopyOrView: Test not yet implemented' - END_FORTRILINOS_UNIT_TEST(TpetraMultiVector_getCopyOrView) - + END_FORTRILINOS_UNIT_TEST(TpetraMultiVector_getCopyOrView) +#endif end program test_TpetraMultiVector diff --git a/src/tpetra/tutorials/MapsAndVectors.F90 b/src/tpetra/tutorials/MapsAndVectors.F90 index c1d0bea5..ad1f2d07 100644 --- a/src/tpetra/tutorials/MapsAndVectors.F90 +++ b/src/tpetra/tutorials/MapsAndVectors.F90 @@ -29,8 +29,8 @@ program main ! -- Scalars integer :: ierr -integer(size_type) :: my_rank, num_procs, k -integer(size_type) :: num_local_entries, num_elements_per_proc +integer :: my_rank, num_procs, k +integer :: num_local_entries, num_elements_per_proc integer(global_size_type) :: num_global_entries logical :: zero_out real(scalar_type) :: alpha, beta, gamma diff --git a/src/tpetra/tutorials/PowerMethod.F90 b/src/tpetra/tutorials/PowerMethod.F90 index 4400235f..8b075778 100644 --- a/src/tpetra/tutorials/PowerMethod.F90 +++ b/src/tpetra/tutorials/PowerMethod.F90 @@ -26,9 +26,6 @@ program main implicit none -! -- Parameters -real(scalar_type), parameter :: one=1., two=2., neg_one=-1. - ! -- ForTrilinos objects type(TeuchosComm) :: comm type(TpetraMap) :: map @@ -38,10 +35,10 @@ program main integer :: ierr real(scalar_type) :: lambda integer(global_size_type) :: num_gbl_indices -integer(size_type) :: my_rank +integer :: my_rank integer(size_type) :: num_entries_in_row, max_entries_per_row, i -integer(local_ordinal_type) lcl_row, row_nnz, n -integer(local_ordinal_type) num_my_elements, col, iconv +integer :: lcl_row, row_nnz, n +integer :: num_my_elements, col, iconv integer(global_ordinal_type) gbl_row, id_of_first_row ! -- Arrays @@ -99,17 +96,17 @@ program main ! A(1, 1:2) = [2, -1] row_nnz = 2 cols(1:2) = [gbl_row, gbl_row+1] - vals(1:2) = [two, neg_one] + vals(1:2) = [2d0, -1d0] else if (gbl_row == num_gbl_indices) then ! A(N, N-1:N) = [-1, 2] row_nnz = 2 cols(1:2) = [gbl_row-1, gbl_row] - vals(1:2) = [neg_one, two] + vals(1:2) = [-1d0, 2d0] else ! A(i, i-1:i+1) = [-1, 2, -1] row_nnz = 3 cols(1:3) = [gbl_row-1, gbl_row, gbl_row+1] - vals(1:3) = [neg_one, two, neg_one] + vals(1:3) = [-1d0, 2d0, -1d0] end if call A%insertGlobalValues(gbl_row, cols(1:row_nnz), vals(1:row_nnz)) end do fill From 709ce03cc8a99aff4a6cf324b9daac65e96845f8 Mon Sep 17 00:00:00 2001 From: Seth R Johnson Date: Sat, 2 Feb 2019 09:50:30 -0500 Subject: [PATCH 10/40] Improve Tpetra_Map interface --- src/teuchos/src/Teuchos_ArrayView.i | 8 +- src/tpetra/src/Tpetra_Map.i | 30 +- src/tpetra/src/fortpetra.i | 1 + src/tpetra/src/swig/fortpetra.F90 | 416 ++++-------- src/tpetra/src/swig/fortpetraFORTRAN_wrap.cxx | 600 +++++------------- 5 files changed, 283 insertions(+), 772 deletions(-) diff --git a/src/teuchos/src/Teuchos_ArrayView.i b/src/teuchos/src/Teuchos_ArrayView.i index 3b8d1fa2..66a22f4b 100644 --- a/src/teuchos/src/Teuchos_ArrayView.i +++ b/src/teuchos/src/Teuchos_ArrayView.i @@ -22,7 +22,12 @@ class ArrayView // Add native wrapping typemaps to convert to/from Teuchos array %fortran_array_pointer(_Tp, ArrayView<_Tp>) - %typemap(in, noblock=1) ArrayView<_Tp> (_Tp* tempbegin, Teuchos::ArrayView<_Tp> temparr) { + %typemap(in, noblock=1) ArrayView<_Tp> (_Tp* tempbegin) { + tempbegin = static_cast<_Tp*>($input->data); + $1 = Teuchos::ArrayView<_Tp>(tempbegin, $input->size); + } + + %typemap(in, noblock=1) const ArrayView<_Tp> & (_Tp* tempbegin, Teuchos::ArrayView<_Tp> temparr) { tempbegin = static_cast<_Tp*>($input->data); temparr = Teuchos::ArrayView<_Tp>(tempbegin, $input->size); $1 = &temparr; @@ -35,7 +40,6 @@ class ArrayView // XXX: %apply only works for *NAME-INSTANTIATED* types, not %template() // types, so we have to manually copy these typemaps. - %typemap(in) const ArrayView<_Tp> & = ArrayView<_Tp>; %typemap(ctype) const ArrayView<_Tp> & = ArrayView<_Tp>; %typemap(imtype) const ArrayView<_Tp> & = ArrayView<_Tp>; %typemap(ftype) const ArrayView<_Tp> & = ArrayView<_Tp>; diff --git a/src/tpetra/src/Tpetra_Map.i b/src/tpetra/src/Tpetra_Map.i index c1c5fe1d..a511eddf 100644 --- a/src/tpetra/src/Tpetra_Map.i +++ b/src/tpetra/src/Tpetra_Map.i @@ -59,10 +59,6 @@ (*$1)[i]++; %} - -// ======================================================================= -// Make interface more Fortran friendly -// ======================================================================= %extend Tpetra::Map { Map(global_size_t numGlobalElements, const Teuchos::RCP > &comm, LocalGlobal lg=GloballyDistributed) { return new Tpetra::Map(numGlobalElements, 1/*indexBase*/, comm, lg); @@ -70,34 +66,14 @@ Map(global_size_t numGlobalElements, size_t numLocalElements, const Teuchos::RCP > &comm) { return new Tpetra::Map(numGlobalElements, numLocalElements, 1/*indexBase*/, comm); } - Map(const global_size_t numGlobalElements, std::pair indexList, const Teuchos::RCP< const Teuchos::Comm< int > > &comm) { - Teuchos::ArrayView indexListView = Teuchos::arrayView(indexList.first, indexList.second); - return new Tpetra::Map(numGlobalElements, indexListView, 1/*indexBase*/, comm); - } - LookupStatus getRemoteIndexList(std::pair GIDList, std::pair nodeIDList, std::pair LIDList) const { - Teuchos::ArrayView GIDListView = Teuchos::arrayView(GIDList.first, GIDList.second); - Teuchos::ArrayView nodeIDListView = Teuchos::arrayView(nodeIDList.first, nodeIDList.second); - Teuchos::ArrayView LIDListView = Teuchos::arrayView(LIDList.first, LIDList.second); - - return self->getRemoteIndexList(GIDListView, nodeIDListView, LIDListView); - } - LookupStatus getRemoteIndexList(std::pair GIDList, std::pair nodeIDList) const { - Teuchos::ArrayView GIDListView = Teuchos::arrayView(GIDList.first, GIDList.second); - Teuchos::ArrayView nodeIDListView = Teuchos::arrayView(nodeIDList.first, nodeIDList.second); - - return self->getRemoteIndexList(GIDListView, nodeIDListView); - } - std::pair getNodeElementList() const { - auto view = self->getNodeElementList(); - return std::make_pair(view.getRawPtr(), view.size()); + Map(const global_size_t numGlobalElements, Teuchos::ArrayView indexList, const Teuchos::RCP< const Teuchos::Comm< int > > &comm) { + return new Tpetra::Map(numGlobalElements, indexList, 1/*indexBase*/, comm); } } + %ignore Tpetra::Map::Map(global_size_t numGlobalElements, GlobalOrdinal indexBase, const Teuchos::RCP > &comm, LocalGlobal lg=GloballyDistributed, const Teuchos::RCP &node=defaultArgNode()); %ignore Tpetra::Map::Map(global_size_t numGlobalElements, size_t numLocalElements, GlobalOrdinal indexBase, const Teuchos::RCP > &comm, const Teuchos::RCP &node=defaultArgNode()); %ignore Tpetra::Map::Map(const global_size_t numGlobalElements, const Teuchos::ArrayView< const GlobalOrdinal > &indexList, const GlobalOrdinal indexBase, const Teuchos::RCP< const Teuchos::Comm< int > > &comm, const Teuchos::RCP< Node > &node=defaultArgNode< Node >()); -%ignore Tpetra::Map::getRemoteIndexList (const Teuchos::ArrayView< const GlobalOrdinal > &GIDList, const Teuchos::ArrayView< int > &nodeIDList, const Teuchos::ArrayView< LocalOrdinal > &LIDList) const; -%ignore Tpetra::Map::getRemoteIndexList (const Teuchos::ArrayView< const GlobalOrdinal > &GIDList, const Teuchos::ArrayView< int > &nodeIDList) const; -%ignore Tpetra::Map::getNodeElementList() const; %include "Tpetra_Map_decl.hpp" diff --git a/src/tpetra/src/fortpetra.i b/src/tpetra/src/fortpetra.i index c58bfa4e..63f86b7e 100644 --- a/src/tpetra/src/fortpetra.i +++ b/src/tpetra/src/fortpetra.i @@ -62,6 +62,7 @@ public :: norm_type // All enums should be prefaced with Tpetra %rename("Tpetra%s", %$isenumitem) ""; %rename("Tpetra%s", %$isenum) ""; +%rename("$ignore", regextarget=1) "Impl$"; %include "Tpetra_ConfigDefs.i" diff --git a/src/tpetra/src/swig/fortpetra.F90 b/src/tpetra/src/swig/fortpetra.F90 index b5323af8..8a2a29af 100644 --- a/src/tpetra/src/swig/fortpetra.F90 +++ b/src/tpetra/src/swig/fortpetra.F90 @@ -136,6 +136,9 @@ module fortpetra procedure :: getMaxAllGlobalIndex => swigf_TpetraMap_getMaxAllGlobalIndex procedure :: getLocalElement => swigf_TpetraMap_getLocalElement procedure :: getGlobalElement => swigf_TpetraMap_getGlobalElement + procedure, private :: getRemoteIndexList__SWIG_0 => swigf_TpetraMap_getRemoteIndexList__SWIG_0 + procedure, private :: getRemoteIndexList__SWIG_1 => swigf_TpetraMap_getRemoteIndexList__SWIG_1 + procedure :: getNodeElementList => swigf_TpetraMap_getNodeElementList procedure :: isNodeLocalElement => swigf_TpetraMap_isNodeLocalElement procedure :: isNodeGlobalElement => swigf_TpetraMap_isNodeGlobalElement procedure :: isUniform => swigf_TpetraMap_isUniform @@ -149,9 +152,6 @@ module fortpetra procedure :: description => swigf_TpetraMap_description procedure :: removeEmptyProcesses => swigf_TpetraMap_removeEmptyProcesses procedure :: replaceCommWithSubset => swigf_TpetraMap_replaceCommWithSubset - procedure, private :: getRemoteIndexList__SWIG_0 => swigf_TpetraMap_getRemoteIndexList__SWIG_0 - procedure, private :: getRemoteIndexList__SWIG_1 => swigf_TpetraMap_getRemoteIndexList__SWIG_1 - procedure :: getNodeElementList => swigf_TpetraMap_getNodeElementList procedure, private :: swigf_assignment_TpetraMap generic :: assignment(=) => swigf_assignment_TpetraMap generic :: getRemoteIndexList => getRemoteIndexList__SWIG_0, getRemoteIndexList__SWIG_1 @@ -403,15 +403,11 @@ module fortpetra procedure :: getNumAllocatedEntriesInGlobalRow => swigf_TpetraCrsGraph_getNumAllocatedEntriesInGlobalRow procedure :: getNumAllocatedEntriesInLocalRow => swigf_TpetraCrsGraph_getNumAllocatedEntriesInLocalRow procedure :: getGlobalNumDiags => swigf_TpetraCrsGraph_getGlobalNumDiags - procedure :: getGlobalNumDiagsImpl => swigf_TpetraCrsGraph_getGlobalNumDiagsImpl procedure :: getNodeNumDiags => swigf_TpetraCrsGraph_getNodeNumDiags - procedure :: getNodeNumDiagsImpl => swigf_TpetraCrsGraph_getNodeNumDiagsImpl procedure :: getGlobalMaxNumRowEntries => swigf_TpetraCrsGraph_getGlobalMaxNumRowEntries procedure :: getNodeMaxNumRowEntries => swigf_TpetraCrsGraph_getNodeMaxNumRowEntries procedure :: hasColMap => swigf_TpetraCrsGraph_hasColMap - procedure :: isLowerTriangularImpl => swigf_TpetraCrsGraph_isLowerTriangularImpl procedure :: isLowerTriangular => swigf_TpetraCrsGraph_isLowerTriangular - procedure :: isUpperTriangularImpl => swigf_TpetraCrsGraph_isUpperTriangularImpl procedure :: isUpperTriangular => swigf_TpetraCrsGraph_isUpperTriangular procedure :: isLocallyIndexed => swigf_TpetraCrsGraph_isLocallyIndexed procedure :: isGloballyIndexed => swigf_TpetraCrsGraph_isGloballyIndexed @@ -521,16 +517,12 @@ module fortpetra procedure :: getNodeNumEntries => swigf_TpetraCrsMatrix_getNodeNumEntries procedure :: getNumEntriesInGlobalRow => swigf_TpetraCrsMatrix_getNumEntriesInGlobalRow procedure :: getNumEntriesInLocalRow => swigf_TpetraCrsMatrix_getNumEntriesInLocalRow - procedure :: getGlobalNumDiagsImpl => swigf_TpetraCrsMatrix_getGlobalNumDiagsImpl procedure :: getGlobalNumDiags => swigf_TpetraCrsMatrix_getGlobalNumDiags - procedure :: getNodeNumDiagsImpl => swigf_TpetraCrsMatrix_getNodeNumDiagsImpl procedure :: getNodeNumDiags => swigf_TpetraCrsMatrix_getNodeNumDiags procedure :: getGlobalMaxNumRowEntries => swigf_TpetraCrsMatrix_getGlobalMaxNumRowEntries procedure :: getNodeMaxNumRowEntries => swigf_TpetraCrsMatrix_getNodeMaxNumRowEntries procedure :: hasColMap => swigf_TpetraCrsMatrix_hasColMap - procedure :: isLowerTriangularImpl => swigf_TpetraCrsMatrix_isLowerTriangularImpl procedure :: isLowerTriangular => swigf_TpetraCrsMatrix_isLowerTriangular - procedure :: isUpperTriangularImpl => swigf_TpetraCrsMatrix_isUpperTriangularImpl procedure :: isUpperTriangular => swigf_TpetraCrsMatrix_isUpperTriangular procedure :: isLocallyIndexed => swigf_TpetraCrsMatrix_isLocallyIndexed procedure :: isGloballyIndexed => swigf_TpetraCrsMatrix_isGloballyIndexed @@ -837,6 +829,41 @@ function swigc_TpetraMap_getGlobalElement(farg1, farg2) & integer(C_LONG_LONG) :: fresult end function +function swigc_TpetraMap_getRemoteIndexList__SWIG_0(farg1, farg2, farg3, farg4) & +bind(C, name="_wrap_TpetraMap_getRemoteIndexList__SWIG_0") & +result(fresult) +use, intrinsic :: ISO_C_BINDING +import :: swigclasswrapper +import :: swigarraywrapper +type(SwigClassWrapper) :: farg1 +type(SwigArrayWrapper) :: farg2 +type(SwigArrayWrapper) :: farg3 +type(SwigArrayWrapper) :: farg4 +integer(C_INT) :: fresult +end function + +function swigc_TpetraMap_getRemoteIndexList__SWIG_1(farg1, farg2, farg3) & +bind(C, name="_wrap_TpetraMap_getRemoteIndexList__SWIG_1") & +result(fresult) +use, intrinsic :: ISO_C_BINDING +import :: swigclasswrapper +import :: swigarraywrapper +type(SwigClassWrapper) :: farg1 +type(SwigArrayWrapper) :: farg2 +type(SwigArrayWrapper) :: farg3 +integer(C_INT) :: fresult +end function + +function swigc_TpetraMap_getNodeElementList(farg1) & +bind(C, name="_wrap_TpetraMap_getNodeElementList") & +result(fresult) +use, intrinsic :: ISO_C_BINDING +import :: swigarraywrapper +import :: swigclasswrapper +type(SwigClassWrapper) :: farg1 +type(SwigArrayWrapper) :: fresult +end function + function swigc_TpetraMap_isNodeLocalElement(farg1, farg2) & bind(C, name="_wrap_TpetraMap_isNodeLocalElement") & result(fresult) @@ -1004,41 +1031,6 @@ function swigc_new_TpetraMap__SWIG_4(farg1, farg2, farg3) & type(SwigArrayWrapper) :: farg2 type(SwigClassWrapper) :: farg3 type(SwigClassWrapper) :: fresult -end function - -function swigc_TpetraMap_getRemoteIndexList__SWIG_0(farg1, farg2, farg3, farg4) & -bind(C, name="_wrap_TpetraMap_getRemoteIndexList__SWIG_0") & -result(fresult) -use, intrinsic :: ISO_C_BINDING -import :: swigclasswrapper -import :: swigarraywrapper -type(SwigClassWrapper) :: farg1 -type(SwigArrayWrapper) :: farg2 -type(SwigArrayWrapper) :: farg3 -type(SwigArrayWrapper) :: farg4 -integer(C_INT) :: fresult -end function - -function swigc_TpetraMap_getRemoteIndexList__SWIG_1(farg1, farg2, farg3) & -bind(C, name="_wrap_TpetraMap_getRemoteIndexList__SWIG_1") & -result(fresult) -use, intrinsic :: ISO_C_BINDING -import :: swigclasswrapper -import :: swigarraywrapper -type(SwigClassWrapper) :: farg1 -type(SwigArrayWrapper) :: farg2 -type(SwigArrayWrapper) :: farg3 -integer(C_INT) :: fresult -end function - -function swigc_TpetraMap_getNodeElementList(farg1) & -bind(C, name="_wrap_TpetraMap_getNodeElementList") & -result(fresult) -use, intrinsic :: ISO_C_BINDING -import :: swigarraywrapper -import :: swigclasswrapper -type(SwigClassWrapper) :: farg1 -type(SwigArrayWrapper) :: fresult end function subroutine swigc_assignment_TpetraMap(self, other) & @@ -2544,15 +2536,6 @@ function swigc_TpetraCrsGraph_getGlobalNumDiags(farg1) & integer(C_LONG) :: fresult end function -function swigc_TpetraCrsGraph_getGlobalNumDiagsImpl(farg1) & -bind(C, name="_wrap_TpetraCrsGraph_getGlobalNumDiagsImpl") & -result(fresult) -use, intrinsic :: ISO_C_BINDING -import :: swigclasswrapper -type(SwigClassWrapper) :: farg1 -integer(C_LONG) :: fresult -end function - function swigc_TpetraCrsGraph_getNodeNumDiags(farg1) & bind(C, name="_wrap_TpetraCrsGraph_getNodeNumDiags") & result(fresult) @@ -2562,15 +2545,6 @@ function swigc_TpetraCrsGraph_getNodeNumDiags(farg1) & integer(C_SIZE_T) :: fresult end function -function swigc_TpetraCrsGraph_getNodeNumDiagsImpl(farg1) & -bind(C, name="_wrap_TpetraCrsGraph_getNodeNumDiagsImpl") & -result(fresult) -use, intrinsic :: ISO_C_BINDING -import :: swigclasswrapper -type(SwigClassWrapper) :: farg1 -integer(C_SIZE_T) :: fresult -end function - function swigc_TpetraCrsGraph_getGlobalMaxNumRowEntries(farg1) & bind(C, name="_wrap_TpetraCrsGraph_getGlobalMaxNumRowEntries") & result(fresult) @@ -2598,15 +2572,6 @@ function swigc_TpetraCrsGraph_hasColMap(farg1) & integer(C_INT) :: fresult end function -function swigc_TpetraCrsGraph_isLowerTriangularImpl(farg1) & -bind(C, name="_wrap_TpetraCrsGraph_isLowerTriangularImpl") & -result(fresult) -use, intrinsic :: ISO_C_BINDING -import :: swigclasswrapper -type(SwigClassWrapper) :: farg1 -integer(C_INT) :: fresult -end function - function swigc_TpetraCrsGraph_isLowerTriangular(farg1) & bind(C, name="_wrap_TpetraCrsGraph_isLowerTriangular") & result(fresult) @@ -2616,15 +2581,6 @@ function swigc_TpetraCrsGraph_isLowerTriangular(farg1) & integer(C_INT) :: fresult end function -function swigc_TpetraCrsGraph_isUpperTriangularImpl(farg1) & -bind(C, name="_wrap_TpetraCrsGraph_isUpperTriangularImpl") & -result(fresult) -use, intrinsic :: ISO_C_BINDING -import :: swigclasswrapper -type(SwigClassWrapper) :: farg1 -integer(C_INT) :: fresult -end function - function swigc_TpetraCrsGraph_isUpperTriangular(farg1) & bind(C, name="_wrap_TpetraCrsGraph_isUpperTriangular") & result(fresult) @@ -3510,15 +3466,6 @@ function swigc_TpetraCrsMatrix_getNumEntriesInLocalRow(farg1, farg2) & integer(C_INT) :: fresult end function -function swigc_TpetraCrsMatrix_getGlobalNumDiagsImpl(farg1) & -bind(C, name="_wrap_TpetraCrsMatrix_getGlobalNumDiagsImpl") & -result(fresult) -use, intrinsic :: ISO_C_BINDING -import :: swigclasswrapper -type(SwigClassWrapper) :: farg1 -integer(C_LONG) :: fresult -end function - function swigc_TpetraCrsMatrix_getGlobalNumDiags(farg1) & bind(C, name="_wrap_TpetraCrsMatrix_getGlobalNumDiags") & result(fresult) @@ -3528,15 +3475,6 @@ function swigc_TpetraCrsMatrix_getGlobalNumDiags(farg1) & integer(C_LONG) :: fresult end function -function swigc_TpetraCrsMatrix_getNodeNumDiagsImpl(farg1) & -bind(C, name="_wrap_TpetraCrsMatrix_getNodeNumDiagsImpl") & -result(fresult) -use, intrinsic :: ISO_C_BINDING -import :: swigclasswrapper -type(SwigClassWrapper) :: farg1 -integer(C_SIZE_T) :: fresult -end function - function swigc_TpetraCrsMatrix_getNodeNumDiags(farg1) & bind(C, name="_wrap_TpetraCrsMatrix_getNodeNumDiags") & result(fresult) @@ -3573,15 +3511,6 @@ function swigc_TpetraCrsMatrix_hasColMap(farg1) & integer(C_INT) :: fresult end function -function swigc_TpetraCrsMatrix_isLowerTriangularImpl(farg1) & -bind(C, name="_wrap_TpetraCrsMatrix_isLowerTriangularImpl") & -result(fresult) -use, intrinsic :: ISO_C_BINDING -import :: swigclasswrapper -type(SwigClassWrapper) :: farg1 -integer(C_INT) :: fresult -end function - function swigc_TpetraCrsMatrix_isLowerTriangular(farg1) & bind(C, name="_wrap_TpetraCrsMatrix_isLowerTriangular") & result(fresult) @@ -3591,15 +3520,6 @@ function swigc_TpetraCrsMatrix_isLowerTriangular(farg1) & integer(C_INT) :: fresult end function -function swigc_TpetraCrsMatrix_isUpperTriangularImpl(farg1) & -bind(C, name="_wrap_TpetraCrsMatrix_isUpperTriangularImpl") & -result(fresult) -use, intrinsic :: ISO_C_BINDING -import :: swigclasswrapper -type(SwigClassWrapper) :: farg1 -integer(C_INT) :: fresult -end function - function swigc_TpetraCrsMatrix_isUpperTriangular(farg1) & bind(C, name="_wrap_TpetraCrsMatrix_isUpperTriangular") & result(fresult) @@ -5069,6 +4989,80 @@ function swigf_TpetraMap_getGlobalElement(self, localindex) & swig_result = fresult end function +function swigf_TpetraMap_getRemoteIndexList__SWIG_0(self, gidlist, nodeidlist, lidlist) & +result(swig_result) +use, intrinsic :: ISO_C_BINDING +integer(TpetraLookupStatus) :: swig_result +class(TpetraMap), intent(in) :: self + +integer(C_LONG_LONG), dimension(:), target :: gidlist +integer(C_LONG_LONG), pointer :: farg2_view +integer(C_INT), dimension(:), target :: nodeidlist +integer(C_INT), pointer :: farg3_view +integer(C_INT), dimension(:), target :: lidlist +integer(C_INT), pointer :: farg4_view + +integer(C_INT) :: fresult +type(SwigClassWrapper) :: farg1 +type(SwigArrayWrapper) :: farg2 +type(SwigArrayWrapper) :: farg3 +type(SwigArrayWrapper) :: farg4 + +farg1 = self%swigdata +farg2_view => gidlist(1) +farg2%data = c_loc(farg2_view) +farg2%size = size(gidlist) +farg3_view => nodeidlist(1) +farg3%data = c_loc(farg3_view) +farg3%size = size(nodeidlist) +farg4_view => lidlist(1) +farg4%data = c_loc(farg4_view) +farg4%size = size(lidlist) +fresult = swigc_TpetraMap_getRemoteIndexList__SWIG_0(farg1, farg2, farg3, farg4) +swig_result = fresult +end function + +function swigf_TpetraMap_getRemoteIndexList__SWIG_1(self, gidlist, nodeidlist) & +result(swig_result) +use, intrinsic :: ISO_C_BINDING +integer(TpetraLookupStatus) :: swig_result +class(TpetraMap), intent(in) :: self + +integer(C_LONG_LONG), dimension(:), target :: gidlist +integer(C_LONG_LONG), pointer :: farg2_view +integer(C_INT), dimension(:), target :: nodeidlist +integer(C_INT), pointer :: farg3_view + +integer(C_INT) :: fresult +type(SwigClassWrapper) :: farg1 +type(SwigArrayWrapper) :: farg2 +type(SwigArrayWrapper) :: farg3 + +farg1 = self%swigdata +farg2_view => gidlist(1) +farg2%data = c_loc(farg2_view) +farg2%size = size(gidlist) +farg3_view => nodeidlist(1) +farg3%data = c_loc(farg3_view) +farg3%size = size(nodeidlist) +fresult = swigc_TpetraMap_getRemoteIndexList__SWIG_1(farg1, farg2, farg3) +swig_result = fresult +end function + +function swigf_TpetraMap_getNodeElementList(self) & +result(swig_result) +use, intrinsic :: ISO_C_BINDING +integer(C_LONG_LONG), dimension(:), pointer :: swig_result +class(TpetraMap), intent(in) :: self + +type(SwigArrayWrapper) :: fresult +type(SwigClassWrapper) :: farg1 + +farg1 = self%swigdata +fresult = swigc_TpetraMap_getNodeElementList(farg1) +call c_f_pointer(fresult%data, swig_result, [fresult%size]) +end function + function swigf_TpetraMap_isNodeLocalElement(self, localindex) & result(swig_result) use, intrinsic :: ISO_C_BINDING @@ -5359,80 +5353,6 @@ function new_TpetraMap__SWIG_4(numglobalelements, indexlist, comm) & farg3 = comm%swigdata fresult = swigc_new_TpetraMap__SWIG_4(farg1, farg2, farg3) self%swigdata = fresult -end function - -function swigf_TpetraMap_getRemoteIndexList__SWIG_0(self, gidlist, nodeidlist, lidlist) & -result(swig_result) -use, intrinsic :: ISO_C_BINDING -integer(TpetraLookupStatus) :: swig_result -class(TpetraMap), intent(in) :: self - -integer(C_LONG_LONG), dimension(:), target :: gidlist -integer(C_LONG_LONG), pointer :: farg2_view -integer(C_INT), dimension(:), target :: nodeidlist -integer(C_INT), pointer :: farg3_view -integer(C_INT), dimension(:), target :: lidlist -integer(C_INT), pointer :: farg4_view - -integer(C_INT) :: fresult -type(SwigClassWrapper) :: farg1 -type(SwigArrayWrapper) :: farg2 -type(SwigArrayWrapper) :: farg3 -type(SwigArrayWrapper) :: farg4 - -farg1 = self%swigdata -farg2_view => gidlist(1) -farg2%data = c_loc(farg2_view) -farg2%size = size(gidlist) -farg3_view => nodeidlist(1) -farg3%data = c_loc(farg3_view) -farg3%size = size(nodeidlist) -farg4_view => lidlist(1) -farg4%data = c_loc(farg4_view) -farg4%size = size(lidlist) -fresult = swigc_TpetraMap_getRemoteIndexList__SWIG_0(farg1, farg2, farg3, farg4) -swig_result = fresult -end function - -function swigf_TpetraMap_getRemoteIndexList__SWIG_1(self, gidlist, nodeidlist) & -result(swig_result) -use, intrinsic :: ISO_C_BINDING -integer(TpetraLookupStatus) :: swig_result -class(TpetraMap), intent(in) :: self - -integer(C_LONG_LONG), dimension(:), target :: gidlist -integer(C_LONG_LONG), pointer :: farg2_view -integer(C_INT), dimension(:), target :: nodeidlist -integer(C_INT), pointer :: farg3_view - -integer(C_INT) :: fresult -type(SwigClassWrapper) :: farg1 -type(SwigArrayWrapper) :: farg2 -type(SwigArrayWrapper) :: farg3 - -farg1 = self%swigdata -farg2_view => gidlist(1) -farg2%data = c_loc(farg2_view) -farg2%size = size(gidlist) -farg3_view => nodeidlist(1) -farg3%data = c_loc(farg3_view) -farg3%size = size(nodeidlist) -fresult = swigc_TpetraMap_getRemoteIndexList__SWIG_1(farg1, farg2, farg3) -swig_result = fresult -end function - -function swigf_TpetraMap_getNodeElementList(self) & -result(swig_result) -use, intrinsic :: ISO_C_BINDING -integer(C_LONG_LONG), dimension(:), pointer :: swig_result -class(TpetraMap), intent(in) :: self - -type(SwigArrayWrapper) :: fresult -type(SwigClassWrapper) :: farg1 - -farg1 = self%swigdata -fresult = swigc_TpetraMap_getNodeElementList(farg1) -call c_f_pointer(fresult%data, swig_result, [fresult%size]) end function subroutine swigf_assignment_TpetraMap(self, other) @@ -8191,20 +8111,6 @@ function swigf_TpetraCrsGraph_getGlobalNumDiags(self) & swig_result = fresult end function -function swigf_TpetraCrsGraph_getGlobalNumDiagsImpl(self) & -result(swig_result) -use, intrinsic :: ISO_C_BINDING -integer(C_LONG) :: swig_result -class(TpetraCrsGraph), intent(in) :: self - -integer(C_LONG) :: fresult -type(SwigClassWrapper) :: farg1 - -farg1 = self%swigdata -fresult = swigc_TpetraCrsGraph_getGlobalNumDiagsImpl(farg1) -swig_result = fresult -end function - function swigf_TpetraCrsGraph_getNodeNumDiags(self) & result(swig_result) use, intrinsic :: ISO_C_BINDING @@ -8219,20 +8125,6 @@ function swigf_TpetraCrsGraph_getNodeNumDiags(self) & swig_result = fresult end function -function swigf_TpetraCrsGraph_getNodeNumDiagsImpl(self) & -result(swig_result) -use, intrinsic :: ISO_C_BINDING -integer(C_SIZE_T) :: swig_result -class(TpetraCrsGraph), intent(in) :: self - -integer(C_SIZE_T) :: fresult -type(SwigClassWrapper) :: farg1 - -farg1 = self%swigdata -fresult = swigc_TpetraCrsGraph_getNodeNumDiagsImpl(farg1) -swig_result = fresult -end function - function swigf_TpetraCrsGraph_getGlobalMaxNumRowEntries(self) & result(swig_result) use, intrinsic :: ISO_C_BINDING @@ -8275,20 +8167,6 @@ function swigf_TpetraCrsGraph_hasColMap(self) & swig_result = SWIG_int_to_logical(fresult) end function -function swigf_TpetraCrsGraph_isLowerTriangularImpl(self) & -result(swig_result) -use, intrinsic :: ISO_C_BINDING -logical :: swig_result -class(TpetraCrsGraph), intent(in) :: self - -integer(C_INT) :: fresult -type(SwigClassWrapper) :: farg1 - -farg1 = self%swigdata -fresult = swigc_TpetraCrsGraph_isLowerTriangularImpl(farg1) -swig_result = SWIG_int_to_logical(fresult) -end function - function swigf_TpetraCrsGraph_isLowerTriangular(self) & result(swig_result) use, intrinsic :: ISO_C_BINDING @@ -8303,20 +8181,6 @@ function swigf_TpetraCrsGraph_isLowerTriangular(self) & swig_result = SWIG_int_to_logical(fresult) end function -function swigf_TpetraCrsGraph_isUpperTriangularImpl(self) & -result(swig_result) -use, intrinsic :: ISO_C_BINDING -logical :: swig_result -class(TpetraCrsGraph), intent(in) :: self - -integer(C_INT) :: fresult -type(SwigClassWrapper) :: farg1 - -farg1 = self%swigdata -fresult = swigc_TpetraCrsGraph_isUpperTriangularImpl(farg1) -swig_result = SWIG_int_to_logical(fresult) -end function - function swigf_TpetraCrsGraph_isUpperTriangular(self) & result(swig_result) use, intrinsic :: ISO_C_BINDING @@ -10043,20 +9907,6 @@ function swigf_TpetraCrsMatrix_getNumEntriesInLocalRow(self, localrow) & swig_result = int(fresult) end function -function swigf_TpetraCrsMatrix_getGlobalNumDiagsImpl(self) & -result(swig_result) -use, intrinsic :: ISO_C_BINDING -integer(C_LONG) :: swig_result -class(TpetraCrsMatrix), intent(in) :: self - -integer(C_LONG) :: fresult -type(SwigClassWrapper) :: farg1 - -farg1 = self%swigdata -fresult = swigc_TpetraCrsMatrix_getGlobalNumDiagsImpl(farg1) -swig_result = fresult -end function - function swigf_TpetraCrsMatrix_getGlobalNumDiags(self) & result(swig_result) use, intrinsic :: ISO_C_BINDING @@ -10071,20 +9921,6 @@ function swigf_TpetraCrsMatrix_getGlobalNumDiags(self) & swig_result = fresult end function -function swigf_TpetraCrsMatrix_getNodeNumDiagsImpl(self) & -result(swig_result) -use, intrinsic :: ISO_C_BINDING -integer(C_SIZE_T) :: swig_result -class(TpetraCrsMatrix), intent(in) :: self - -integer(C_SIZE_T) :: fresult -type(SwigClassWrapper) :: farg1 - -farg1 = self%swigdata -fresult = swigc_TpetraCrsMatrix_getNodeNumDiagsImpl(farg1) -swig_result = fresult -end function - function swigf_TpetraCrsMatrix_getNodeNumDiags(self) & result(swig_result) use, intrinsic :: ISO_C_BINDING @@ -10141,20 +9977,6 @@ function swigf_TpetraCrsMatrix_hasColMap(self) & swig_result = SWIG_int_to_logical(fresult) end function -function swigf_TpetraCrsMatrix_isLowerTriangularImpl(self) & -result(swig_result) -use, intrinsic :: ISO_C_BINDING -logical :: swig_result -class(TpetraCrsMatrix), intent(in) :: self - -integer(C_INT) :: fresult -type(SwigClassWrapper) :: farg1 - -farg1 = self%swigdata -fresult = swigc_TpetraCrsMatrix_isLowerTriangularImpl(farg1) -swig_result = SWIG_int_to_logical(fresult) -end function - function swigf_TpetraCrsMatrix_isLowerTriangular(self) & result(swig_result) use, intrinsic :: ISO_C_BINDING @@ -10169,20 +9991,6 @@ function swigf_TpetraCrsMatrix_isLowerTriangular(self) & swig_result = SWIG_int_to_logical(fresult) end function -function swigf_TpetraCrsMatrix_isUpperTriangularImpl(self) & -result(swig_result) -use, intrinsic :: ISO_C_BINDING -logical :: swig_result -class(TpetraCrsMatrix), intent(in) :: self - -integer(C_INT) :: fresult -type(SwigClassWrapper) :: farg1 - -farg1 = self%swigdata -fresult = swigc_TpetraCrsMatrix_isUpperTriangularImpl(farg1) -swig_result = SWIG_int_to_logical(fresult) -end function - function swigf_TpetraCrsMatrix_isUpperTriangular(self) & result(swig_result) use, intrinsic :: ISO_C_BINDING diff --git a/src/tpetra/src/swig/fortpetraFORTRAN_wrap.cxx b/src/tpetra/src/swig/fortpetraFORTRAN_wrap.cxx index ec37e92a..1b976fec 100644 --- a/src/tpetra/src/swig/fortpetraFORTRAN_wrap.cxx +++ b/src/tpetra/src/swig/fortpetraFORTRAN_wrap.cxx @@ -356,26 +356,8 @@ SWIGINTERN Tpetra::Map< LO,GO,NO > *new_Tpetra_Map_Sl_LO_Sc_GO_Sc_NO_Sg___SWIG_1 SWIGINTERN Tpetra::Map< LO,GO,NO > *new_Tpetra_Map_Sl_LO_Sc_GO_Sc_NO_Sg___SWIG_3(Tpetra::global_size_t numGlobalElements,size_t numLocalElements,Teuchos::RCP< Teuchos::Comm< int > const > const &comm){ return new Tpetra::Map(numGlobalElements, numLocalElements, 1/*indexBase*/, comm); } -SWIGINTERN Tpetra::Map< LO,GO,NO > *new_Tpetra_Map_Sl_LO_Sc_GO_Sc_NO_Sg___SWIG_4(Tpetra::global_size_t const numGlobalElements,std::pair< GO const *,std::size_t > indexList,Teuchos::RCP< Teuchos::Comm< int > const > const &comm){ - Teuchos::ArrayView indexListView = Teuchos::arrayView(indexList.first, indexList.second); - return new Tpetra::Map(numGlobalElements, indexListView, 1/*indexBase*/, comm); - } -SWIGINTERN Tpetra::LookupStatus Tpetra_Map_Sl_LO_Sc_GO_Sc_NO_Sg__getRemoteIndexList__SWIG_0(Tpetra::Map< LO,GO,NO > const *self,std::pair< GO const *,std::size_t > GIDList,std::pair< int *,std::size_t > nodeIDList,std::pair< LO *,std::size_t > LIDList){ - Teuchos::ArrayView GIDListView = Teuchos::arrayView(GIDList.first, GIDList.second); - Teuchos::ArrayView nodeIDListView = Teuchos::arrayView(nodeIDList.first, nodeIDList.second); - Teuchos::ArrayView LIDListView = Teuchos::arrayView(LIDList.first, LIDList.second); - - return self->getRemoteIndexList(GIDListView, nodeIDListView, LIDListView); - } -SWIGINTERN Tpetra::LookupStatus Tpetra_Map_Sl_LO_Sc_GO_Sc_NO_Sg__getRemoteIndexList__SWIG_1(Tpetra::Map< LO,GO,NO > const *self,std::pair< GO const *,std::size_t > GIDList,std::pair< int *,std::size_t > nodeIDList){ - Teuchos::ArrayView GIDListView = Teuchos::arrayView(GIDList.first, GIDList.second); - Teuchos::ArrayView nodeIDListView = Teuchos::arrayView(nodeIDList.first, nodeIDList.second); - - return self->getRemoteIndexList(GIDListView, nodeIDListView); - } -SWIGINTERN std::pair< GO const *,std::size_t > Tpetra_Map_Sl_LO_Sc_GO_Sc_NO_Sg__getNodeElementList(Tpetra::Map< LO,GO,NO > const *self){ - auto view = self->getNodeElementList(); - return std::make_pair(view.getRawPtr(), view.size()); +SWIGINTERN Tpetra::Map< LO,GO,NO > *new_Tpetra_Map_Sl_LO_Sc_GO_Sc_NO_Sg___SWIG_4(Tpetra::global_size_t const numGlobalElements,Teuchos::ArrayView< GO const > indexList,Teuchos::RCP< Teuchos::Comm< int > const > const &comm){ + return new Tpetra::Map(numGlobalElements, indexList, 1/*indexBase*/, comm); } #include @@ -1571,6 +1553,157 @@ SWIGEXPORT long long _wrap_TpetraMap_getGlobalElement(SwigClassWrapper const *fa } +SWIGEXPORT int _wrap_TpetraMap_getRemoteIndexList__SWIG_0(SwigClassWrapper const *farg1, SwigArrayWrapper *farg2, SwigArrayWrapper *farg3, SwigArrayWrapper *farg4) { + int fresult ; + Tpetra::Map< LO,GO,NO > *arg1 = (Tpetra::Map< LO,GO,NO > *) 0 ; + Teuchos::ArrayView< long long const > *arg2 = 0 ; + Teuchos::ArrayView< int > *arg3 = 0 ; + Teuchos::ArrayView< int > *arg4 = 0 ; + Teuchos::RCP< Tpetra::Map< LO,GO,NO > const > *smartarg1 ; + long long const *tempbegin2 ; + Teuchos::ArrayView< long long const > temparr2 ; + int *tempbegin3 ; + Teuchos::ArrayView< int > temparr3 ; + int *tempbegin4 ; + Teuchos::ArrayView< int > temparr4 ; + Tpetra::LookupStatus result; + + smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::Map* >(smartarg1->get()) : NULL; + tempbegin2 = static_cast(farg2->data); + temparr2 = Teuchos::ArrayView(tempbegin2, farg2->size); + arg2 = &temparr2; + tempbegin3 = static_cast(farg3->data); + temparr3 = Teuchos::ArrayView(tempbegin3, farg3->size); + arg3 = &temparr3; + tempbegin4 = static_cast(farg4->data); + temparr4 = Teuchos::ArrayView(tempbegin4, farg4->size); + arg4 = &temparr4; + { + // Make sure no unhandled exceptions exist before performing a new action + SWIG_check_unhandled_exception_impl("Tpetra::Map< LO,GO,NO >::getRemoteIndexList(Teuchos::ArrayView< long long const > const &,Teuchos::ArrayView< int > const &,Teuchos::ArrayView< int > const &) const");; + try + { + // Attempt the wrapped function call + result = (Tpetra::LookupStatus)((Tpetra::Map< LO,GO,NO > const *)arg1)->getRemoteIndexList((Teuchos::ArrayView< long long const > const &)*arg2,(Teuchos::ArrayView< int > const &)*arg3,(Teuchos::ArrayView< int > const &)*arg4); + } + catch (const std::range_error& e) + { + // Store a C++ exception + SWIG_exception_impl("Tpetra::Map< LO,GO,NO >::getRemoteIndexList(Teuchos::ArrayView< long long const > const &,Teuchos::ArrayView< int > const &,Teuchos::ArrayView< int > const &) const", SWIG_IndexError, e.what(), return 0); + } + catch (const std::exception& e) + { + // Store a C++ exception + SWIG_exception_impl("Tpetra::Map< LO,GO,NO >::getRemoteIndexList(Teuchos::ArrayView< long long const > const &,Teuchos::ArrayView< int > const &,Teuchos::ArrayView< int > const &) const", SWIG_RuntimeError, e.what(), return 0); + } + catch (...) + { + SWIG_exception_impl("Tpetra::Map< LO,GO,NO >::getRemoteIndexList(Teuchos::ArrayView< long long const > const &,Teuchos::ArrayView< int > const &,Teuchos::ArrayView< int > const &) const", SWIG_UnknownError, "An unknown exception occurred", return 0); + } + } + fresult = static_cast< int >(result); + + for (int i = 0; i < arg3->size(); i++) + (*arg3)[i]++; + + + for (int i = 0; i < arg4->size(); i++) + (*arg4)[i]++; + + return fresult; +} + + +SWIGEXPORT int _wrap_TpetraMap_getRemoteIndexList__SWIG_1(SwigClassWrapper const *farg1, SwigArrayWrapper *farg2, SwigArrayWrapper *farg3) { + int fresult ; + Tpetra::Map< LO,GO,NO > *arg1 = (Tpetra::Map< LO,GO,NO > *) 0 ; + Teuchos::ArrayView< long long const > *arg2 = 0 ; + Teuchos::ArrayView< int > *arg3 = 0 ; + Teuchos::RCP< Tpetra::Map< LO,GO,NO > const > *smartarg1 ; + long long const *tempbegin2 ; + Teuchos::ArrayView< long long const > temparr2 ; + int *tempbegin3 ; + Teuchos::ArrayView< int > temparr3 ; + Tpetra::LookupStatus result; + + smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::Map* >(smartarg1->get()) : NULL; + tempbegin2 = static_cast(farg2->data); + temparr2 = Teuchos::ArrayView(tempbegin2, farg2->size); + arg2 = &temparr2; + tempbegin3 = static_cast(farg3->data); + temparr3 = Teuchos::ArrayView(tempbegin3, farg3->size); + arg3 = &temparr3; + { + // Make sure no unhandled exceptions exist before performing a new action + SWIG_check_unhandled_exception_impl("Tpetra::Map< LO,GO,NO >::getRemoteIndexList(Teuchos::ArrayView< long long const > const &,Teuchos::ArrayView< int > const &) const");; + try + { + // Attempt the wrapped function call + result = (Tpetra::LookupStatus)((Tpetra::Map< LO,GO,NO > const *)arg1)->getRemoteIndexList((Teuchos::ArrayView< long long const > const &)*arg2,(Teuchos::ArrayView< int > const &)*arg3); + } + catch (const std::range_error& e) + { + // Store a C++ exception + SWIG_exception_impl("Tpetra::Map< LO,GO,NO >::getRemoteIndexList(Teuchos::ArrayView< long long const > const &,Teuchos::ArrayView< int > const &) const", SWIG_IndexError, e.what(), return 0); + } + catch (const std::exception& e) + { + // Store a C++ exception + SWIG_exception_impl("Tpetra::Map< LO,GO,NO >::getRemoteIndexList(Teuchos::ArrayView< long long const > const &,Teuchos::ArrayView< int > const &) const", SWIG_RuntimeError, e.what(), return 0); + } + catch (...) + { + SWIG_exception_impl("Tpetra::Map< LO,GO,NO >::getRemoteIndexList(Teuchos::ArrayView< long long const > const &,Teuchos::ArrayView< int > const &) const", SWIG_UnknownError, "An unknown exception occurred", return 0); + } + } + fresult = static_cast< int >(result); + + for (int i = 0; i < arg3->size(); i++) + (*arg3)[i]++; + + return fresult; +} + + +SWIGEXPORT SwigArrayWrapper _wrap_TpetraMap_getNodeElementList(SwigClassWrapper const *farg1) { + SwigArrayWrapper fresult ; + Tpetra::Map< LO,GO,NO > *arg1 = (Tpetra::Map< LO,GO,NO > *) 0 ; + Teuchos::RCP< Tpetra::Map< LO,GO,NO > const > *smartarg1 ; + Teuchos::ArrayView< long long const > result; + + smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::Map* >(smartarg1->get()) : NULL; + { + // Make sure no unhandled exceptions exist before performing a new action + SWIG_check_unhandled_exception_impl("Tpetra::Map< LO,GO,NO >::getNodeElementList() const");; + try + { + // Attempt the wrapped function call + result = ((Tpetra::Map< LO,GO,NO > const *)arg1)->getNodeElementList(); + } + catch (const std::range_error& e) + { + // Store a C++ exception + SWIG_exception_impl("Tpetra::Map< LO,GO,NO >::getNodeElementList() const", SWIG_IndexError, e.what(), return SwigArrayWrapper_uninitialized()); + } + catch (const std::exception& e) + { + // Store a C++ exception + SWIG_exception_impl("Tpetra::Map< LO,GO,NO >::getNodeElementList() const", SWIG_RuntimeError, e.what(), return SwigArrayWrapper_uninitialized()); + } + catch (...) + { + SWIG_exception_impl("Tpetra::Map< LO,GO,NO >::getNodeElementList() const", SWIG_UnknownError, "An unknown exception occurred", return SwigArrayWrapper_uninitialized()); + } + } + fresult.data = (void*)(&result)->getRawPtr(); + fresult.size = (&result)->size(); + return fresult; +} + + SWIGEXPORT int _wrap_TpetraMap_isNodeLocalElement(SwigClassWrapper const *farg1, int const *farg2) { int fresult ; Tpetra::Map< LO,GO,NO > *arg1 = (Tpetra::Map< LO,GO,NO > *) 0 ; @@ -2196,18 +2329,19 @@ SWIGEXPORT SwigClassWrapper _wrap_new_TpetraMap__SWIG_3(long const *farg1, int c SWIGEXPORT SwigClassWrapper _wrap_new_TpetraMap__SWIG_4(long const *farg1, SwigArrayWrapper *farg2, SwigClassWrapper const *farg3) { SwigClassWrapper fresult ; Tpetra::global_size_t arg1 ; - std::pair< GO const *,std::size_t > arg2 ; + Teuchos::ArrayView< GO const > arg2 ; Teuchos::RCP< Teuchos::Comm< int > const > *arg3 = 0 ; + long long const *tempbegin2 ; Teuchos::RCP< Teuchos::Comm< int > const > tempnull3 ; Tpetra::Map< LO,GO,NO > *result = 0 ; arg1 = static_cast< Tpetra::global_size_t >(*farg1); - (&arg2)->first = static_cast(farg2->data); - (&arg2)->second = farg2->size; + tempbegin2 = static_cast(farg2->data); + arg2 = Teuchos::ArrayView(tempbegin2, farg2->size); arg3 = farg3->cptr ? static_cast< Teuchos::RCP< Teuchos::Comm< int > const > * >(farg3->cptr) : &tempnull3; { // Make sure no unhandled exceptions exist before performing a new action - SWIG_check_unhandled_exception_impl("Tpetra::Map< LO,GO,NO >::Map(Tpetra::global_size_t const,std::pair< GO const *,std::size_t >,Teuchos::RCP< Teuchos::Comm< int > const > const &)");; + SWIG_check_unhandled_exception_impl("Tpetra::Map< LO,GO,NO >::Map(Tpetra::global_size_t const,Teuchos::ArrayView< GO const >,Teuchos::RCP< Teuchos::Comm< int > const > const &)");; try { // Attempt the wrapped function call @@ -2216,16 +2350,16 @@ SWIGEXPORT SwigClassWrapper _wrap_new_TpetraMap__SWIG_4(long const *farg1, SwigA catch (const std::range_error& e) { // Store a C++ exception - SWIG_exception_impl("Tpetra::Map< LO,GO,NO >::Map(Tpetra::global_size_t const,std::pair< GO const *,std::size_t >,Teuchos::RCP< Teuchos::Comm< int > const > const &)", SWIG_IndexError, e.what(), return SwigClassWrapper_uninitialized()); + SWIG_exception_impl("Tpetra::Map< LO,GO,NO >::Map(Tpetra::global_size_t const,Teuchos::ArrayView< GO const >,Teuchos::RCP< Teuchos::Comm< int > const > const &)", SWIG_IndexError, e.what(), return SwigClassWrapper_uninitialized()); } catch (const std::exception& e) { // Store a C++ exception - SWIG_exception_impl("Tpetra::Map< LO,GO,NO >::Map(Tpetra::global_size_t const,std::pair< GO const *,std::size_t >,Teuchos::RCP< Teuchos::Comm< int > const > const &)", SWIG_RuntimeError, e.what(), return SwigClassWrapper_uninitialized()); + SWIG_exception_impl("Tpetra::Map< LO,GO,NO >::Map(Tpetra::global_size_t const,Teuchos::ArrayView< GO const >,Teuchos::RCP< Teuchos::Comm< int > const > const &)", SWIG_RuntimeError, e.what(), return SwigClassWrapper_uninitialized()); } catch (...) { - SWIG_exception_impl("Tpetra::Map< LO,GO,NO >::Map(Tpetra::global_size_t const,std::pair< GO const *,std::size_t >,Teuchos::RCP< Teuchos::Comm< int > const > const &)", SWIG_UnknownError, "An unknown exception occurred", return SwigClassWrapper_uninitialized()); + SWIG_exception_impl("Tpetra::Map< LO,GO,NO >::Map(Tpetra::global_size_t const,Teuchos::ArrayView< GO const >,Teuchos::RCP< Teuchos::Comm< int > const > const &)", SWIG_UnknownError, "An unknown exception occurred", return SwigClassWrapper_uninitialized()); } } fresult.cptr = result ? new Teuchos::RCP< Tpetra::Map >(result SWIG_NO_NULL_DELETER_1) : NULL; @@ -2234,130 +2368,6 @@ SWIGEXPORT SwigClassWrapper _wrap_new_TpetraMap__SWIG_4(long const *farg1, SwigA } -SWIGEXPORT int _wrap_TpetraMap_getRemoteIndexList__SWIG_0(SwigClassWrapper const *farg1, SwigArrayWrapper *farg2, SwigArrayWrapper *farg3, SwigArrayWrapper *farg4) { - int fresult ; - Tpetra::Map< LO,GO,NO > *arg1 = (Tpetra::Map< LO,GO,NO > *) 0 ; - std::pair< GO const *,std::size_t > arg2 ; - std::pair< int *,std::size_t > arg3 ; - std::pair< LO *,std::size_t > arg4 ; - Teuchos::RCP< Tpetra::Map< LO,GO,NO > const > *smartarg1 ; - Tpetra::LookupStatus result; - - smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); - arg1 = smartarg1 ? const_cast< Tpetra::Map* >(smartarg1->get()) : NULL; - (&arg2)->first = static_cast(farg2->data); - (&arg2)->second = farg2->size; - (&arg3)->first = static_cast(farg3->data); - (&arg3)->second = farg3->size; - (&arg4)->first = static_cast(farg4->data); - (&arg4)->second = farg4->size; - { - // Make sure no unhandled exceptions exist before performing a new action - SWIG_check_unhandled_exception_impl("Tpetra::Map< LO,GO,NO >::getRemoteIndexList(std::pair< GO const *,std::size_t >,std::pair< int *,std::size_t >,std::pair< LO *,std::size_t >) const");; - try - { - // Attempt the wrapped function call - result = (Tpetra::LookupStatus)Tpetra_Map_Sl_LO_Sc_GO_Sc_NO_Sg__getRemoteIndexList__SWIG_0((Tpetra::Map< int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const *)arg1,arg2,arg3,arg4); - } - catch (const std::range_error& e) - { - // Store a C++ exception - SWIG_exception_impl("Tpetra::Map< LO,GO,NO >::getRemoteIndexList(std::pair< GO const *,std::size_t >,std::pair< int *,std::size_t >,std::pair< LO *,std::size_t >) const", SWIG_IndexError, e.what(), return 0); - } - catch (const std::exception& e) - { - // Store a C++ exception - SWIG_exception_impl("Tpetra::Map< LO,GO,NO >::getRemoteIndexList(std::pair< GO const *,std::size_t >,std::pair< int *,std::size_t >,std::pair< LO *,std::size_t >) const", SWIG_RuntimeError, e.what(), return 0); - } - catch (...) - { - SWIG_exception_impl("Tpetra::Map< LO,GO,NO >::getRemoteIndexList(std::pair< GO const *,std::size_t >,std::pair< int *,std::size_t >,std::pair< LO *,std::size_t >) const", SWIG_UnknownError, "An unknown exception occurred", return 0); - } - } - fresult = static_cast< int >(result); - return fresult; -} - - -SWIGEXPORT int _wrap_TpetraMap_getRemoteIndexList__SWIG_1(SwigClassWrapper const *farg1, SwigArrayWrapper *farg2, SwigArrayWrapper *farg3) { - int fresult ; - Tpetra::Map< LO,GO,NO > *arg1 = (Tpetra::Map< LO,GO,NO > *) 0 ; - std::pair< GO const *,std::size_t > arg2 ; - std::pair< int *,std::size_t > arg3 ; - Teuchos::RCP< Tpetra::Map< LO,GO,NO > const > *smartarg1 ; - Tpetra::LookupStatus result; - - smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); - arg1 = smartarg1 ? const_cast< Tpetra::Map* >(smartarg1->get()) : NULL; - (&arg2)->first = static_cast(farg2->data); - (&arg2)->second = farg2->size; - (&arg3)->first = static_cast(farg3->data); - (&arg3)->second = farg3->size; - { - // Make sure no unhandled exceptions exist before performing a new action - SWIG_check_unhandled_exception_impl("Tpetra::Map< LO,GO,NO >::getRemoteIndexList(std::pair< GO const *,std::size_t >,std::pair< int *,std::size_t >) const");; - try - { - // Attempt the wrapped function call - result = (Tpetra::LookupStatus)Tpetra_Map_Sl_LO_Sc_GO_Sc_NO_Sg__getRemoteIndexList__SWIG_1((Tpetra::Map< int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const *)arg1,arg2,arg3); - } - catch (const std::range_error& e) - { - // Store a C++ exception - SWIG_exception_impl("Tpetra::Map< LO,GO,NO >::getRemoteIndexList(std::pair< GO const *,std::size_t >,std::pair< int *,std::size_t >) const", SWIG_IndexError, e.what(), return 0); - } - catch (const std::exception& e) - { - // Store a C++ exception - SWIG_exception_impl("Tpetra::Map< LO,GO,NO >::getRemoteIndexList(std::pair< GO const *,std::size_t >,std::pair< int *,std::size_t >) const", SWIG_RuntimeError, e.what(), return 0); - } - catch (...) - { - SWIG_exception_impl("Tpetra::Map< LO,GO,NO >::getRemoteIndexList(std::pair< GO const *,std::size_t >,std::pair< int *,std::size_t >) const", SWIG_UnknownError, "An unknown exception occurred", return 0); - } - } - fresult = static_cast< int >(result); - return fresult; -} - - -SWIGEXPORT SwigArrayWrapper _wrap_TpetraMap_getNodeElementList(SwigClassWrapper const *farg1) { - SwigArrayWrapper fresult ; - Tpetra::Map< LO,GO,NO > *arg1 = (Tpetra::Map< LO,GO,NO > *) 0 ; - Teuchos::RCP< Tpetra::Map< LO,GO,NO > const > *smartarg1 ; - std::pair< GO const *,std::size_t > result; - - smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); - arg1 = smartarg1 ? const_cast< Tpetra::Map* >(smartarg1->get()) : NULL; - { - // Make sure no unhandled exceptions exist before performing a new action - SWIG_check_unhandled_exception_impl("Tpetra::Map< LO,GO,NO >::getNodeElementList() const");; - try - { - // Attempt the wrapped function call - result = Tpetra_Map_Sl_LO_Sc_GO_Sc_NO_Sg__getNodeElementList((Tpetra::Map< int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const *)arg1); - } - catch (const std::range_error& e) - { - // Store a C++ exception - SWIG_exception_impl("Tpetra::Map< LO,GO,NO >::getNodeElementList() const", SWIG_IndexError, e.what(), return SwigArrayWrapper_uninitialized()); - } - catch (const std::exception& e) - { - // Store a C++ exception - SWIG_exception_impl("Tpetra::Map< LO,GO,NO >::getNodeElementList() const", SWIG_RuntimeError, e.what(), return SwigArrayWrapper_uninitialized()); - } - catch (...) - { - SWIG_exception_impl("Tpetra::Map< LO,GO,NO >::getNodeElementList() const", SWIG_UnknownError, "An unknown exception occurred", return SwigArrayWrapper_uninitialized()); - } - } - fresult.data = const_cast((&result)->first); - fresult.size = (&result)->second; - return fresult; -} - - SWIGEXPORT void _wrap_assign_TpetraMap(SwigClassWrapper * self, SwigClassWrapper const * other) { typedef Teuchos::RCP< Tpetra::Map > swig_lhs_classtype; SWIG_assign(swig_lhs_classtype, self, @@ -8258,42 +8268,6 @@ SWIGEXPORT long _wrap_TpetraCrsGraph_getGlobalNumDiags(SwigClassWrapper const *f } -SWIGEXPORT long _wrap_TpetraCrsGraph_getGlobalNumDiagsImpl(SwigClassWrapper const *farg1) { - long fresult ; - Tpetra::CrsGraph< LO,GO,NO > *arg1 = (Tpetra::CrsGraph< LO,GO,NO > *) 0 ; - Teuchos::RCP< Tpetra::CrsGraph< LO,GO,NO > const > *smartarg1 ; - Tpetra::global_size_t result; - - smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); - arg1 = smartarg1 ? const_cast< Tpetra::CrsGraph* >(smartarg1->get()) : NULL; - { - // Make sure no unhandled exceptions exist before performing a new action - SWIG_check_unhandled_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::getGlobalNumDiagsImpl() const");; - try - { - // Attempt the wrapped function call - result = (Tpetra::global_size_t)((Tpetra::CrsGraph< LO,GO,NO > const *)arg1)->getGlobalNumDiagsImpl(); - } - catch (const std::range_error& e) - { - // Store a C++ exception - SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::getGlobalNumDiagsImpl() const", SWIG_IndexError, e.what(), return 0); - } - catch (const std::exception& e) - { - // Store a C++ exception - SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::getGlobalNumDiagsImpl() const", SWIG_RuntimeError, e.what(), return 0); - } - catch (...) - { - SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::getGlobalNumDiagsImpl() const", SWIG_UnknownError, "An unknown exception occurred", return 0); - } - } - fresult = static_cast< Tpetra::global_size_t >(result); - return fresult; -} - - SWIGEXPORT size_t _wrap_TpetraCrsGraph_getNodeNumDiags(SwigClassWrapper const *farg1) { size_t fresult ; Tpetra::CrsGraph< LO,GO,NO > *arg1 = (Tpetra::CrsGraph< LO,GO,NO > *) 0 ; @@ -8330,42 +8304,6 @@ SWIGEXPORT size_t _wrap_TpetraCrsGraph_getNodeNumDiags(SwigClassWrapper const *f } -SWIGEXPORT size_t _wrap_TpetraCrsGraph_getNodeNumDiagsImpl(SwigClassWrapper const *farg1) { - size_t fresult ; - Tpetra::CrsGraph< LO,GO,NO > *arg1 = (Tpetra::CrsGraph< LO,GO,NO > *) 0 ; - Teuchos::RCP< Tpetra::CrsGraph< LO,GO,NO > const > *smartarg1 ; - size_t result; - - smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); - arg1 = smartarg1 ? const_cast< Tpetra::CrsGraph* >(smartarg1->get()) : NULL; - { - // Make sure no unhandled exceptions exist before performing a new action - SWIG_check_unhandled_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::getNodeNumDiagsImpl() const");; - try - { - // Attempt the wrapped function call - result = (size_t)((Tpetra::CrsGraph< LO,GO,NO > const *)arg1)->getNodeNumDiagsImpl(); - } - catch (const std::range_error& e) - { - // Store a C++ exception - SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::getNodeNumDiagsImpl() const", SWIG_IndexError, e.what(), return 0); - } - catch (const std::exception& e) - { - // Store a C++ exception - SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::getNodeNumDiagsImpl() const", SWIG_RuntimeError, e.what(), return 0); - } - catch (...) - { - SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::getNodeNumDiagsImpl() const", SWIG_UnknownError, "An unknown exception occurred", return 0); - } - } - fresult = static_cast< size_t >(result); - return fresult; -} - - SWIGEXPORT size_t _wrap_TpetraCrsGraph_getGlobalMaxNumRowEntries(SwigClassWrapper const *farg1) { size_t fresult ; Tpetra::CrsGraph< LO,GO,NO > *arg1 = (Tpetra::CrsGraph< LO,GO,NO > *) 0 ; @@ -8474,42 +8412,6 @@ SWIGEXPORT int _wrap_TpetraCrsGraph_hasColMap(SwigClassWrapper const *farg1) { } -SWIGEXPORT int _wrap_TpetraCrsGraph_isLowerTriangularImpl(SwigClassWrapper const *farg1) { - int fresult ; - Tpetra::CrsGraph< LO,GO,NO > *arg1 = (Tpetra::CrsGraph< LO,GO,NO > *) 0 ; - Teuchos::RCP< Tpetra::CrsGraph< LO,GO,NO > const > *smartarg1 ; - bool result; - - smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); - arg1 = smartarg1 ? const_cast< Tpetra::CrsGraph* >(smartarg1->get()) : NULL; - { - // Make sure no unhandled exceptions exist before performing a new action - SWIG_check_unhandled_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::isLowerTriangularImpl() const");; - try - { - // Attempt the wrapped function call - result = (bool)((Tpetra::CrsGraph< LO,GO,NO > const *)arg1)->isLowerTriangularImpl(); - } - catch (const std::range_error& e) - { - // Store a C++ exception - SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::isLowerTriangularImpl() const", SWIG_IndexError, e.what(), return 0); - } - catch (const std::exception& e) - { - // Store a C++ exception - SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::isLowerTriangularImpl() const", SWIG_RuntimeError, e.what(), return 0); - } - catch (...) - { - SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::isLowerTriangularImpl() const", SWIG_UnknownError, "An unknown exception occurred", return 0); - } - } - fresult = (result ? 1 : 0); - return fresult; -} - - SWIGEXPORT int _wrap_TpetraCrsGraph_isLowerTriangular(SwigClassWrapper const *farg1) { int fresult ; Tpetra::CrsGraph< LO,GO,NO > *arg1 = (Tpetra::CrsGraph< LO,GO,NO > *) 0 ; @@ -8546,42 +8448,6 @@ SWIGEXPORT int _wrap_TpetraCrsGraph_isLowerTriangular(SwigClassWrapper const *fa } -SWIGEXPORT int _wrap_TpetraCrsGraph_isUpperTriangularImpl(SwigClassWrapper const *farg1) { - int fresult ; - Tpetra::CrsGraph< LO,GO,NO > *arg1 = (Tpetra::CrsGraph< LO,GO,NO > *) 0 ; - Teuchos::RCP< Tpetra::CrsGraph< LO,GO,NO > const > *smartarg1 ; - bool result; - - smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); - arg1 = smartarg1 ? const_cast< Tpetra::CrsGraph* >(smartarg1->get()) : NULL; - { - // Make sure no unhandled exceptions exist before performing a new action - SWIG_check_unhandled_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::isUpperTriangularImpl() const");; - try - { - // Attempt the wrapped function call - result = (bool)((Tpetra::CrsGraph< LO,GO,NO > const *)arg1)->isUpperTriangularImpl(); - } - catch (const std::range_error& e) - { - // Store a C++ exception - SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::isUpperTriangularImpl() const", SWIG_IndexError, e.what(), return 0); - } - catch (const std::exception& e) - { - // Store a C++ exception - SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::isUpperTriangularImpl() const", SWIG_RuntimeError, e.what(), return 0); - } - catch (...) - { - SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::isUpperTriangularImpl() const", SWIG_UnknownError, "An unknown exception occurred", return 0); - } - } - fresult = (result ? 1 : 0); - return fresult; -} - - SWIGEXPORT int _wrap_TpetraCrsGraph_isUpperTriangular(SwigClassWrapper const *farg1) { int fresult ; Tpetra::CrsGraph< LO,GO,NO > *arg1 = (Tpetra::CrsGraph< LO,GO,NO > *) 0 ; @@ -12136,42 +12002,6 @@ SWIGEXPORT int _wrap_TpetraCrsMatrix_getNumEntriesInLocalRow(SwigClassWrapper co } -SWIGEXPORT long _wrap_TpetraCrsMatrix_getGlobalNumDiagsImpl(SwigClassWrapper const *farg1) { - long fresult ; - Tpetra::CrsMatrix< SC,LO,GO,NO > *arg1 = (Tpetra::CrsMatrix< SC,LO,GO,NO > *) 0 ; - Teuchos::RCP< Tpetra::CrsMatrix< SC,LO,GO,NO > const > *smartarg1 ; - Tpetra::global_size_t result; - - smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); - arg1 = smartarg1 ? const_cast< Tpetra::CrsMatrix* >(smartarg1->get()) : NULL; - { - // Make sure no unhandled exceptions exist before performing a new action - SWIG_check_unhandled_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::getGlobalNumDiagsImpl() const");; - try - { - // Attempt the wrapped function call - result = (Tpetra::global_size_t)((Tpetra::CrsMatrix< SC,LO,GO,NO > const *)arg1)->getGlobalNumDiagsImpl(); - } - catch (const std::range_error& e) - { - // Store a C++ exception - SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::getGlobalNumDiagsImpl() const", SWIG_IndexError, e.what(), return 0); - } - catch (const std::exception& e) - { - // Store a C++ exception - SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::getGlobalNumDiagsImpl() const", SWIG_RuntimeError, e.what(), return 0); - } - catch (...) - { - SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::getGlobalNumDiagsImpl() const", SWIG_UnknownError, "An unknown exception occurred", return 0); - } - } - fresult = static_cast< Tpetra::global_size_t >(result); - return fresult; -} - - SWIGEXPORT long _wrap_TpetraCrsMatrix_getGlobalNumDiags(SwigClassWrapper const *farg1) { long fresult ; Tpetra::CrsMatrix< SC,LO,GO,NO > *arg1 = (Tpetra::CrsMatrix< SC,LO,GO,NO > *) 0 ; @@ -12208,42 +12038,6 @@ SWIGEXPORT long _wrap_TpetraCrsMatrix_getGlobalNumDiags(SwigClassWrapper const * } -SWIGEXPORT size_t _wrap_TpetraCrsMatrix_getNodeNumDiagsImpl(SwigClassWrapper const *farg1) { - size_t fresult ; - Tpetra::CrsMatrix< SC,LO,GO,NO > *arg1 = (Tpetra::CrsMatrix< SC,LO,GO,NO > *) 0 ; - Teuchos::RCP< Tpetra::CrsMatrix< SC,LO,GO,NO > const > *smartarg1 ; - size_t result; - - smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); - arg1 = smartarg1 ? const_cast< Tpetra::CrsMatrix* >(smartarg1->get()) : NULL; - { - // Make sure no unhandled exceptions exist before performing a new action - SWIG_check_unhandled_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::getNodeNumDiagsImpl() const");; - try - { - // Attempt the wrapped function call - result = (size_t)((Tpetra::CrsMatrix< SC,LO,GO,NO > const *)arg1)->getNodeNumDiagsImpl(); - } - catch (const std::range_error& e) - { - // Store a C++ exception - SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::getNodeNumDiagsImpl() const", SWIG_IndexError, e.what(), return 0); - } - catch (const std::exception& e) - { - // Store a C++ exception - SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::getNodeNumDiagsImpl() const", SWIG_RuntimeError, e.what(), return 0); - } - catch (...) - { - SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::getNodeNumDiagsImpl() const", SWIG_UnknownError, "An unknown exception occurred", return 0); - } - } - fresult = static_cast< size_t >(result); - return fresult; -} - - SWIGEXPORT size_t _wrap_TpetraCrsMatrix_getNodeNumDiags(SwigClassWrapper const *farg1) { size_t fresult ; Tpetra::CrsMatrix< SC,LO,GO,NO > *arg1 = (Tpetra::CrsMatrix< SC,LO,GO,NO > *) 0 ; @@ -12388,42 +12182,6 @@ SWIGEXPORT int _wrap_TpetraCrsMatrix_hasColMap(SwigClassWrapper const *farg1) { } -SWIGEXPORT int _wrap_TpetraCrsMatrix_isLowerTriangularImpl(SwigClassWrapper const *farg1) { - int fresult ; - Tpetra::CrsMatrix< SC,LO,GO,NO > *arg1 = (Tpetra::CrsMatrix< SC,LO,GO,NO > *) 0 ; - Teuchos::RCP< Tpetra::CrsMatrix< SC,LO,GO,NO > const > *smartarg1 ; - bool result; - - smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); - arg1 = smartarg1 ? const_cast< Tpetra::CrsMatrix* >(smartarg1->get()) : NULL; - { - // Make sure no unhandled exceptions exist before performing a new action - SWIG_check_unhandled_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::isLowerTriangularImpl() const");; - try - { - // Attempt the wrapped function call - result = (bool)((Tpetra::CrsMatrix< SC,LO,GO,NO > const *)arg1)->isLowerTriangularImpl(); - } - catch (const std::range_error& e) - { - // Store a C++ exception - SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::isLowerTriangularImpl() const", SWIG_IndexError, e.what(), return 0); - } - catch (const std::exception& e) - { - // Store a C++ exception - SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::isLowerTriangularImpl() const", SWIG_RuntimeError, e.what(), return 0); - } - catch (...) - { - SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::isLowerTriangularImpl() const", SWIG_UnknownError, "An unknown exception occurred", return 0); - } - } - fresult = (result ? 1 : 0); - return fresult; -} - - SWIGEXPORT int _wrap_TpetraCrsMatrix_isLowerTriangular(SwigClassWrapper const *farg1) { int fresult ; Tpetra::CrsMatrix< SC,LO,GO,NO > *arg1 = (Tpetra::CrsMatrix< SC,LO,GO,NO > *) 0 ; @@ -12460,42 +12218,6 @@ SWIGEXPORT int _wrap_TpetraCrsMatrix_isLowerTriangular(SwigClassWrapper const *f } -SWIGEXPORT int _wrap_TpetraCrsMatrix_isUpperTriangularImpl(SwigClassWrapper const *farg1) { - int fresult ; - Tpetra::CrsMatrix< SC,LO,GO,NO > *arg1 = (Tpetra::CrsMatrix< SC,LO,GO,NO > *) 0 ; - Teuchos::RCP< Tpetra::CrsMatrix< SC,LO,GO,NO > const > *smartarg1 ; - bool result; - - smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); - arg1 = smartarg1 ? const_cast< Tpetra::CrsMatrix* >(smartarg1->get()) : NULL; - { - // Make sure no unhandled exceptions exist before performing a new action - SWIG_check_unhandled_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::isUpperTriangularImpl() const");; - try - { - // Attempt the wrapped function call - result = (bool)((Tpetra::CrsMatrix< SC,LO,GO,NO > const *)arg1)->isUpperTriangularImpl(); - } - catch (const std::range_error& e) - { - // Store a C++ exception - SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::isUpperTriangularImpl() const", SWIG_IndexError, e.what(), return 0); - } - catch (const std::exception& e) - { - // Store a C++ exception - SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::isUpperTriangularImpl() const", SWIG_RuntimeError, e.what(), return 0); - } - catch (...) - { - SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::isUpperTriangularImpl() const", SWIG_UnknownError, "An unknown exception occurred", return 0); - } - } - fresult = (result ? 1 : 0); - return fresult; -} - - SWIGEXPORT int _wrap_TpetraCrsMatrix_isUpperTriangular(SwigClassWrapper const *farg1) { int fresult ; Tpetra::CrsMatrix< SC,LO,GO,NO > *arg1 = (Tpetra::CrsMatrix< SC,LO,GO,NO > *) 0 ; From 0f09dd8751a043cddb693da27416ad538d2294ab Mon Sep 17 00:00:00 2001 From: Seth R Johnson Date: Mon, 4 Feb 2019 08:56:18 -0500 Subject: [PATCH 11/40] Switch to typemaps in several classes This also removes a couple of functions that were returning arrayviews *by reference* (e.g. getGlobalRowView), so the wrappers that were in place actually did nothing. --- src/teuchos/src/Teuchos_ArrayView.i | 4 + src/tpetra/src/Tpetra_CrsGraph.i | 125 +- src/tpetra/src/Tpetra_CrsMatrix.i | 129 +- src/tpetra/src/Tpetra_Export.i | 10 +- src/tpetra/src/Tpetra_MultiVector.i | 29 +- src/tpetra/src/fortpetra.i | 27 +- src/tpetra/src/swig/fortpetra.F90 | 817 ++++----- src/tpetra/src/swig/fortpetraFORTRAN_wrap.cxx | 1537 ++++++++--------- src/tpetra/test/test_tpetra_import_export.F90 | 14 +- 9 files changed, 1223 insertions(+), 1469 deletions(-) diff --git a/src/teuchos/src/Teuchos_ArrayView.i b/src/teuchos/src/Teuchos_ArrayView.i index 66a22f4b..1fe6386c 100644 --- a/src/teuchos/src/Teuchos_ArrayView.i +++ b/src/teuchos/src/Teuchos_ArrayView.i @@ -53,6 +53,10 @@ class ArrayView %template() Teuchos::ArrayView; %template() Teuchos::ArrayView; +%template() Teuchos::ArrayView; +%template() Teuchos::ArrayView; +%template() Teuchos::ArrayView; + %template() Teuchos::ArrayView; %template() Teuchos::ArrayView; %template() Teuchos::ArrayView; diff --git a/src/tpetra/src/Tpetra_CrsGraph.i b/src/tpetra/src/Tpetra_CrsGraph.i index 606ddcd9..c23e1a0c 100644 --- a/src/tpetra/src/Tpetra_CrsGraph.i +++ b/src/tpetra/src/Tpetra_CrsGraph.i @@ -62,28 +62,13 @@ %ignore Tpetra::CrsGraph::getLocalGraph; // needs Kokkos::StaticCrsGraph %ignore Tpetra::CrsGraph::getLocalRowView; // ±1 issue +// Returns ArrayView by reference +%ignore Tpetra::CrsGraph::getGlobalRowView; + // ======================================================================= // Fix ±1 issues // ======================================================================= -%typemap(in) int localRow %{$1 = *$input - 1;%} -%typemap(argout) const Teuchos::ArrayView< int > &indices %{ - for (int i = 0; i < $1->size(); i++) - (*$1)[i]++; -%} -%typemap(in, noblock=1) const Teuchos::ArrayView< int > &indices () { - - // Original typemap: convert void* to thinvec reference - $1 = %static_cast(%const_cast($input, void*), $1_ltype); - - // Construct temporary array and view - Teuchos::Array tmp = Teuchos::Array($1->size()); - for (int i = 0; i < $1->size(); i++) - tmp[i] = (*$1)[i] - 1; - Teuchos::ArrayView tmpview = tmp(); - - // Make the input argument point to our temporary vector - $1 = &tmpview; -} +%apply int INDEX { int localRow }; %apply int { size_t getNumEntriesInLocalRow, size_t getNumAllocatedEntriesInLocalRow} @@ -93,98 +78,81 @@ // ======================================================================= %extend Tpetra::CrsGraph { CrsGraph(const Teuchos::RCP< const map_type > &rowMap, - std::pair numEntPerRow, + Teuchos::ArrayView numEntPerRow, const ProfileType pftype=DynamicProfile, const Teuchos::RCP< Teuchos::ParameterList > ¶ms=Teuchos::null) { - Teuchos::ArrayRCP numEntPerRowRCP(numEntPerRow.first, 0, numEntPerRow.second, false/*has_ownership*/); - return new Tpetra::CrsGraph(rowMap, numEntPerRowRCP, pftype, params); + return new Tpetra::CrsGraph(rowMap, arcpFromArrayView(numEntPerRow), pftype, params); } CrsGraph(const Teuchos::RCP< const map_type > &rowMap, const Teuchos::RCP< const map_type > &colMap, - std::pair numEntPerRow, + Teuchos::ArrayView numEntPerRow, const ProfileType pftype=DynamicProfile, const Teuchos::RCP< Teuchos::ParameterList > ¶ms=Teuchos::null) { - Teuchos::ArrayRCP numEntPerRowRCP(numEntPerRow.first, 0, numEntPerRow.second, false/*has_ownership*/); - return new Tpetra::CrsGraph(rowMap, colMap, numEntPerRowRCP, pftype, params); + return new Tpetra::CrsGraph(rowMap, colMap, arcpFromArrayView(numEntPerRow), pftype, params); } CrsGraph(const Teuchos::RCP< const map_type > &rowMap, const Teuchos::RCP< const map_type > &colMap, - std::pair rowPointers, - std::pair columnIndices, + Teuchos::ArrayView rowPointers, + Teuchos::ArrayView columnIndices, const Teuchos::RCP< Teuchos::ParameterList > ¶ms=Teuchos::null) { - Teuchos::Array rowPointersArray(rowPointers.second); - for (size_t i = 0; i < rowPointers.second; i++) - rowPointersArray[i] = rowPointers.first[i]-1; - Teuchos::Array columnIndicesArray(columnIndices.second); - for (size_t i = 0; i < columnIndices.second; i++) - columnIndicesArray[i] = columnIndices.first[i]-1; + Teuchos::Array rowPointersArray(rowPointers.size()); + for (size_t i = 0; i < rowPointers.size(); i++) + rowPointersArray[i] = rowPointers[i]-1; + Teuchos::Array columnIndicesArray(columnIndices.size()); + for (size_t i = 0; i < columnIndices.size(); i++) + columnIndicesArray[i] = columnIndices[i]-1; return new Tpetra::CrsGraph(rowMap, colMap, Teuchos::arcpFromArray(rowPointersArray), Teuchos::arcpFromArray(columnIndicesArray), params); } - void insertGlobalIndices(const GO globalRow, std::pair indices) { - Teuchos::ArrayView indicesView = Teuchos::arrayView(indices.first, indices.second); - self->insertGlobalIndices(globalRow, indicesView); + void insertGlobalIndices(const GO globalRow, Teuchos::ArrayView indicesView) { + $self->insertGlobalIndices(globalRow, indicesView); } - void insertLocalIndices(const LO localRow, std::pair indices) { - Teuchos::Array indicesArray(indices.second); + void insertLocalIndices(const LO localRow, Teuchos::ArrayView indices) { + Teuchos::Array indicesArray(indices.size()); for (size_t i = 0; i < indicesArray.size(); i++) - indicesArray[i] = indices.first[i]-1; - self->insertLocalIndices(localRow, indicesArray); - } - void getGlobalRowCopy(GO GlobalRow, std::pair Indices, size_t &NumIndices) const { - Teuchos::ArrayView IndicesView = Teuchos::arrayView(Indices.first, Indices.second); - self->getGlobalRowCopy(GlobalRow, IndicesView, NumIndices); + indicesArray[i] = indices[i]-1; + $self->insertLocalIndices(localRow, indicesArray); } - void getLocalRowCopy(LO localRow, std::pair indices, size_t &NumIndices) const { - Teuchos::ArrayView indicesView = Teuchos::arrayView(indices.first, indices.second); - self->getLocalRowCopy(localRow, indicesView, NumIndices); + void getLocalRowCopy(LO localRow, Teuchos::ArrayView indicesView, size_t &NumIndices) const { + $self->getLocalRowCopy(localRow, indicesView, NumIndices); for (int i = 0; i < indicesView.size(); i++) indicesView[i]++; } - void getGlobalRowView(const GO gblRow, std::pair lclColInds) const { - Teuchos::ArrayView lclColIndsView = Teuchos::arrayView(lclColInds.first, lclColInds.second); - self->getGlobalRowView(gblRow, lclColIndsView); - } - void setAllIndices(std::pair rowPointers, std::pair columnIndices, std::pair val) { - Teuchos::ArrayRCP rowPointersArrayRCP(rowPointers.second); + void setAllIndices(Teuchos::ArrayView rowPointers, Teuchos::ArrayView columnIndices, Teuchos::ArrayView val) { + Teuchos::ArrayRCP rowPointersArrayRCP(rowPointers.size()); for (int i = 0; i < rowPointersArrayRCP.size(); i++) - rowPointersArrayRCP[i] = rowPointers.first[i]-1; - Teuchos::ArrayRCP columnIndicesArrayRCP(columnIndices.second); + rowPointersArrayRCP[i] = rowPointers[i]-1; + Teuchos::ArrayRCP columnIndicesArrayRCP(columnIndices.size()); for (int i = 0; i < columnIndicesArrayRCP.size(); i++) - columnIndicesArrayRCP[i] = columnIndices.first[i]-1; - self->setAllIndices(rowPointersArrayRCP, columnIndicesArrayRCP); + columnIndicesArrayRCP[i] = columnIndices[i]-1; + $self->setAllIndices(rowPointersArrayRCP, columnIndicesArrayRCP); } // NOTE: This is semantically different function from Tpetra. Here, we *require* that user already allocated the arrays to store the data - void getNodeRowPtrs(std::pair rowPointers) const { - auto rowPointersArrayRCP = self->getNodeRowPtrs(); - TEUCHOS_TEST_FOR_EXCEPTION(rowPointersArrayRCP.size() != rowPointers.second, std::runtime_error, "Wrong rowPointers size"); - auto n = rowPointers.second; + void getNodeRowPtrs(Teuchos::ArrayView rowPointers) const { + auto rowPointersArrayRCP = $self->getNodeRowPtrs(); + TEUCHOS_TEST_FOR_EXCEPTION(rowPointersArrayRCP.size() != rowPointers.size(), std::runtime_error, "Wrong rowPointers size"); + auto n = rowPointers.size(); for (int i = 0; i < n; i++) - rowPointers.first[i] = rowPointersArrayRCP[i]+1; + rowPointers[i] = rowPointersArrayRCP[i]+1; } - void getNodePackedIndices(std::pair columnIndices) const { - auto columnIndicesArrayRCP = self->getNodeRowPtrs(); - TEUCHOS_TEST_FOR_EXCEPTION(columnIndicesArrayRCP.size() != columnIndices.second, std::runtime_error, "Wrong columnIndices size"); - auto nnz = columnIndices.second; + void getNodePackedIndices(Teuchos::ArrayView columnIndices) const { + auto columnIndicesArrayRCP = $self->getNodeRowPtrs(); + TEUCHOS_TEST_FOR_EXCEPTION(columnIndicesArrayRCP.size() != columnIndices.size(), std::runtime_error, "Wrong columnIndices size"); + auto nnz = columnIndices.size(); for (int i = 0; i < nnz; i++) - columnIndices.first[i] = columnIndicesArrayRCP[i]+1; - } - void getLocalDiagOffsets (std::pair offsets) const { - TEUCHOS_TEST_FOR_EXCEPTION(self->getNodeNumRows() != offsets.second, std::runtime_error, "Wrong offsets size"); - Teuchos::ArrayRCP offsetsArrayRCP(offsets.first, 0, offsets.second, false/*has_ownership*/); - self->getLocalDiagOffsets(offsetsArrayRCP); + columnIndices[i] = columnIndicesArrayRCP[i]+1; } void doImport (const Tpetra::CrsGraph &source, const Tpetra::Import< LO, GO, NO > &importer, CombineMode CM) { - self->doImport(source, importer, CM); + $self->doImport(source, importer, CM); } void doImport (const Tpetra::CrsGraph &source, const Tpetra::Export< LO, GO, NO > &exporter, CombineMode CM) { - self->doImport(source, exporter, CM); + $self->doImport(source, exporter, CM); } void doExport (const Tpetra::CrsGraph &source, const Tpetra::Export< LO, GO, NO > &exporter, CombineMode CM) { - self->doExport(source, exporter, CM); + $self->doExport(source, exporter, CM); } void doExport (const Tpetra::CrsGraph &source, const Tpetra::Import< LO, GO, NO > &importer, CombineMode CM) { - self->doExport(source, importer, CM); + $self->doExport(source, importer, CM); } } %ignore Tpetra::CrsGraph::CrsGraph (const Teuchos::RCP< const map_type > &rowMap, @@ -202,13 +170,10 @@ const Teuchos::RCP< Teuchos::ParameterList > ¶ms=Teuchos::null); // needs Teuchos::ArrayRCP; ±1 issue %ignore Tpetra::CrsGraph::insertGlobalIndices (const GlobalOrdinal globalRow, const Teuchos::ArrayView< const GlobalOrdinal > &indices); %ignore Tpetra::CrsGraph::insertLocalIndices(const LocalOrdinal localRow, const Teuchos::ArrayView< const LocalOrdinal > &indices); -%ignore Tpetra::CrsGraph::getGlobalRowCopy(GlobalOrdinal GlobalRow, const Teuchos::ArrayView< GlobalOrdinal > &Indices, size_t &NumIndices) const; %ignore Tpetra::CrsGraph::getLocalRowCopy(LocalOrdinal LocalRow, const Teuchos::ArrayView< LocalOrdinal > &indices, size_t &NumIndices) const; -%ignore Tpetra::CrsGraph::getGlobalRowView(const GlobalOrdinal gblRow, Teuchos::ArrayView< const GlobalOrdinal > &gblColInds) const; -%ignore Tpetra::CrsGraph::getLocalRowView(const LocalOrdinal lclRow, Teuchos::ArrayView< const LocalOrdinal > &lclColInds) const; %ignore Tpetra::CrsGraph::getNodeRowPtrs() const; %ignore Tpetra::CrsGraph::getNodePackedIndices() const; -%ignore Tpetra::CrsGraph::getLocalDiagOffsets (Teuchos::ArrayRCP< size_t > &offsets) const; +%ignore Tpetra::CrsGraph::getLocalDiagOffsets; %ignore Tpetra::CrsGraph::setAllIndices (const Teuchos::ArrayRCP< size_t > &rowPointers, const Teuchos::ArrayRCP< LocalOrdinal > &columnIndices); %ignore Tpetra::CrsGraph::setAllIndices (const typename local_graph_type::row_map_type &rowPointers, const typename local_graph_type::entries_type::non_const_type &columnIndices); diff --git a/src/tpetra/src/Tpetra_CrsMatrix.i b/src/tpetra/src/Tpetra_CrsMatrix.i index 9b79c55e..a8d1c9d0 100644 --- a/src/tpetra/src/Tpetra_CrsMatrix.i +++ b/src/tpetra/src/Tpetra_CrsMatrix.i @@ -91,113 +91,77 @@ // Make interface more Fortran friendly // ======================================================================= %extend Tpetra::CrsMatrix { - CrsMatrix(const Teuchos::RCP& rowMap, std::pair NumEntriesPerRowToAlloc, ProfileType pftype = DynamicProfile, const Teuchos::RCP& params = Teuchos::null) { - Teuchos::ArrayRCP NumEntriesPerRowToAllocArrayRCP(NumEntriesPerRowToAlloc.first, 0, NumEntriesPerRowToAlloc.second, false/*has_ownership*/); - return new Tpetra::CrsMatrix(rowMap, NumEntriesPerRowToAllocArrayRCP, pftype, params); + CrsMatrix(const Teuchos::RCP& rowMap, Teuchos::ArrayView NumEntriesPerRowToAlloc, ProfileType pftype = DynamicProfile, const Teuchos::RCP& params = Teuchos::null) { + return new Tpetra::CrsMatrix(rowMap, arcpFromArrayView(NumEntriesPerRowToAlloc), pftype, params); } - CrsMatrix(const Teuchos::RCP& rowMap, const Teuchos::RCP& colMap, std::pair NumEntriesPerRowToAlloc, ProfileType pftype = DynamicProfile, const Teuchos::RCP& params = Teuchos::null) { - Teuchos::ArrayRCP NumEntriesPerRowToAllocArrayRCP(NumEntriesPerRowToAlloc.first, 0, NumEntriesPerRowToAlloc.second, false/*has_ownership*/); - return new Tpetra::CrsMatrix(rowMap, colMap, NumEntriesPerRowToAllocArrayRCP, pftype, params); + CrsMatrix(const Teuchos::RCP& rowMap, const Teuchos::RCP& colMap, Teuchos::ArrayView NumEntriesPerRowToAlloc, ProfileType pftype = DynamicProfile, const Teuchos::RCP& params = Teuchos::null) { + return new Tpetra::CrsMatrix(rowMap, colMap, arcpFromArrayView(NumEntriesPerRowToAlloc), pftype, params); } - CrsMatrix (const Teuchos::RCP& rowMap, const Teuchos::RCP& colMap, std::pair rowPointers, std::pair columnIndices, std::pair values, const Teuchos::RCP& params = Teuchos::null) { - Teuchos::ArrayRCP rowPointersArrayRCP(rowPointers.second); + CrsMatrix (const Teuchos::RCP& rowMap, const Teuchos::RCP& colMap, Teuchos::ArrayView rowPointers, Teuchos::ArrayView columnIndices, Teuchos::ArrayView values, const Teuchos::RCP& params = Teuchos::null) { + Teuchos::ArrayRCP rowPointersArrayRCP(rowPointers.size()); for (int i = 0; i < rowPointersArrayRCP.size(); i++) - rowPointersArrayRCP[i] = rowPointers.first[i]-1; - Teuchos::ArrayRCP columnIndicesArrayRCP(columnIndices.second); + rowPointersArrayRCP[i] = rowPointers[i]-1; + Teuchos::ArrayRCP columnIndicesArrayRCP(columnIndices.size()); for (int i = 0; i < columnIndicesArrayRCP.size(); i++) - columnIndicesArrayRCP[i] = columnIndices.first[i]-1; - Teuchos::ArrayRCP valuesArrayRCP(values.first, 0, values.second, false/*has_ownership*/); - return new Tpetra::CrsMatrix(rowMap, colMap, rowPointersArrayRCP, columnIndicesArrayRCP, valuesArrayRCP, params); + columnIndicesArrayRCP[i] = columnIndices[i]-1; + return new Tpetra::CrsMatrix(rowMap, colMap, rowPointersArrayRCP, columnIndicesArrayRCP, arcpFromArrayView(values), params); } - void insertGlobalValues(const GO globalRow, std::pair cols, std::pair vals) { - Teuchos::ArrayView colsView = Teuchos::arrayView(cols.first, cols.second); - Teuchos::ArrayView valsView = Teuchos::arrayView(vals.first, vals.second); - self->insertGlobalValues(globalRow, colsView, valsView); - } - void insertLocalValues(const LO localRow, std::pair cols, std::pair vals) { - Teuchos::Array colsArray(cols.second); + void insertLocalValues(const LO localRow, Teuchos::ArrayView cols, Teuchos::ArrayView vals) { + Teuchos::Array colsArray(cols.size()); for (int i = 0; i < colsArray.size(); i++) - colsArray[i] = cols.first[i] - 1; - Teuchos::ArrayView valsView = Teuchos::arrayView(vals.first, vals.second); + colsArray[i] = cols[i] - 1; + Teuchos::ArrayView valsView = Teuchos::arrayView(vals.getRawPtr(), vals.size()); self->insertLocalValues(localRow, colsArray, valsView); } - LO replaceGlobalValues(const GO globalRow, std::pair cols, std::pair vals) const { - Teuchos::ArrayView colsView = Teuchos::arrayView(cols.first, cols.second); - Teuchos::ArrayView valsView = Teuchos::arrayView(vals.first, vals.second); - return self->replaceGlobalValues(globalRow, colsView, valsView); - } - LO replaceLocalValues(const LO localRow, std::pair cols, std::pair vals) const { - Teuchos::Array colsArray(cols.second); + LO replaceLocalValues(const LO localRow, Teuchos::ArrayView cols, Teuchos::ArrayView vals) const { + Teuchos::Array colsArray(cols.size()); for (int i = 0; i < colsArray.size(); i++) - colsArray[i] = cols.first[i] - 1; - Teuchos::ArrayView valsView = Teuchos::arrayView(vals.first, vals.second); - return self->replaceLocalValues(localRow, colsArray, valsView); + colsArray[i] = cols[i] - 1; + return self->replaceLocalValues(localRow, colsArray, vals); } - LO sumIntoGlobalValues(const GO globalRow, std::pair cols, std::pair vals) { - Teuchos::ArrayView colsView = Teuchos::arrayView(cols.first, cols.second); - Teuchos::ArrayView valsView = Teuchos::arrayView(vals.first, vals.second); - return self->sumIntoGlobalValues(globalRow, colsView, valsView, false); // TODO: for now, we only run in serial, no atomics necessary + LO sumIntoGlobalValues(const GO globalRow, Teuchos::ArrayView cols, Teuchos::ArrayView vals) { + return self->sumIntoGlobalValues(globalRow, cols, vals, false); // TODO: for now, we only run in serial, no atomics necessary } - LO sumIntoLocalValues(const LO localRow, std::pair cols, std::pair vals) const { - Teuchos::Array colsArray(cols.second); + LO sumIntoLocalValues(const LO localRow, Teuchos::ArrayView cols, Teuchos::ArrayView vals) const { + Teuchos::Array colsArray(cols.size()); for (int i = 0; i < colsArray.size(); i++) - colsArray[i] = cols.first[i] - 1; - Teuchos::ArrayView valsView = Teuchos::arrayView(vals.first, vals.second); + colsArray[i] = cols[i] - 1; + Teuchos::ArrayView valsView = Teuchos::arrayView(vals.getRawPtr(), vals.size()); return self->sumIntoLocalValues(localRow, colsArray, valsView, false/*atomic*/); // TODO: for now, we only run in serial, no atomics necessary } - void setAllValues(std::pair ptr, std::pair ind, std::pair val) { - Teuchos::ArrayRCP ptrArrayRCP(ptr.second); + void setAllValues(Teuchos::ArrayView ptr, Teuchos::ArrayView ind, Teuchos::ArrayView val) { + Teuchos::ArrayRCP ptrArrayRCP(ptr.size()); for (int i = 0; i < ptrArrayRCP.size(); i++) - ptrArrayRCP[i] = ptr.first[i]-1; - Teuchos::ArrayRCP indArrayRCP(ind.second); + ptrArrayRCP[i] = ptr[i]-1; + Teuchos::ArrayRCP indArrayRCP(ind.size()); for (int i = 0; i < indArrayRCP.size(); i++) - indArrayRCP[i] = ind.first[i]-1; - Teuchos::ArrayRCP valArrayRCP(val.first, 0, val.second, false/*has_ownership*/); - self->setAllValues(ptrArrayRCP, indArrayRCP, valArrayRCP); + indArrayRCP[i] = ind[i]-1; + Teuchos::ArrayRCP valArrayRCP(val.getRawPtr(), 0, val.size(), false/*has_ownership*/); + self->setAllValues(arcpFromArrayView(ptr), arcpFromArrayView(ind), arcpFromArrayView(val)); } // NOTE: This is semantically different function from Tpetra. Here, we *require* that user already allocated the arrays to store the data - void getAllValues(std::pair rowPointers, std::pair columnIndices, std::pair values) const { + void getAllValues(Teuchos::ArrayView rowPointers, Teuchos::ArrayView columnIndices, Teuchos::ArrayView values) const { Teuchos::ArrayRCP rowPointersArrayRCP; Teuchos::ArrayRCP columnIndicesArrayRCP; Teuchos::ArrayRCP valuesArrayRCP; self->getAllValues(rowPointersArrayRCP, columnIndicesArrayRCP, valuesArrayRCP); - TEUCHOS_TEST_FOR_EXCEPTION(rowPointersArrayRCP.size() != rowPointers.second, std::runtime_error, "Wrong rowPointers size"); - TEUCHOS_TEST_FOR_EXCEPTION(columnIndicesArrayRCP.size() != columnIndices.second, std::runtime_error, "Wrong columnIndices size"); - TEUCHOS_TEST_FOR_EXCEPTION(valuesArrayRCP.size() != values.second, std::runtime_error, "Wrong values size"); - auto n = rowPointers.second; + TEUCHOS_TEST_FOR_EXCEPTION(rowPointersArrayRCP.size() != rowPointers.size(), std::runtime_error, "Wrong rowPointers size"); + TEUCHOS_TEST_FOR_EXCEPTION(columnIndicesArrayRCP.size() != columnIndices.size(), std::runtime_error, "Wrong columnIndices size"); + TEUCHOS_TEST_FOR_EXCEPTION(valuesArrayRCP.size() != values.size(), std::runtime_error, "Wrong values size"); + auto n = rowPointers.size(); for (int i = 0; i < n; i++) - rowPointers.first[i] = rowPointersArrayRCP[i]+1; - auto nnz = columnIndices.second; + rowPointers[i] = rowPointersArrayRCP[i]+1; + auto nnz = columnIndices.size(); for (int i = 0; i < nnz; i++) { - columnIndices.first[i] = columnIndicesArrayRCP[i]+1; - values .first[i] = valuesArrayRCP[i]; + columnIndices[i] = columnIndicesArrayRCP[i]+1; + values [i] = valuesArrayRCP[i]; } } - void getGlobalRowCopy(GO GlobalRow, std::pair Indices, std::pair Values, size_t &NumIndices) const { - Teuchos::ArrayView IndicesView = Teuchos::arrayView(Indices.first, Indices.second); - Teuchos::ArrayView ValuesView = Teuchos::arrayView(Values.first, Values.second); - - self->getGlobalRowCopy(GlobalRow, IndicesView, ValuesView, NumIndices); - } - void getLocalRowCopy(LO localRow, std::pair colInds, std::pair vals, size_t &NumIndices) const { - Teuchos::ArrayView colIndsView = Teuchos::arrayView(colInds.first, colInds.second); - Teuchos::ArrayView valsView = Teuchos::arrayView(vals.first, vals.second); + void getLocalRowCopy(LO localRow, Teuchos::ArrayView colInds, Teuchos::ArrayView vals, size_t &NumIndices) const { + self->getLocalRowCopy(localRow, colInds, vals, NumIndices); - self->getLocalRowCopy(localRow, colIndsView, valsView, NumIndices); - - for (int i = 0; i < colIndsView.size(); i++) - colIndsView[i]++; - } - void getGlobalRowView(GO GlobalRow, std::pair Indices, std::pair values) const { - Teuchos::ArrayView IndicesView = Teuchos::arrayView(Indices.first, Indices.second); - Teuchos::ArrayView valuesView = Teuchos::arrayView(values.first, values.second); - - self->getGlobalRowView(GlobalRow, IndicesView, valuesView); - } - void getLocalDiagOffsets (std::pair offsets) const { - TEUCHOS_TEST_FOR_EXCEPTION(self->getNodeNumRows() != offsets.second, std::runtime_error, "Wrong offsets size"); - Teuchos::ArrayRCP offsetsArrayRCP(offsets.first, 0, offsets.second, false/*has_ownership*/); - self->getLocalDiagOffsets(offsetsArrayRCP); + for (int i = 0; i < colInds.size(); i++) + colInds[i]++; } void doImport (const Tpetra::CrsMatrix &source, const Tpetra::Import< LO, GO, NO > &importer, CombineMode CM) { self->doImport(source, importer, CM); @@ -227,17 +191,12 @@ const Teuchos::ArrayRCP& columnIndices, const Teuchos::ArrayRCP& values, const Teuchos::RCP& params = Teuchos::null); // needs Teuchos::ArrayRCP -%ignore Tpetra::CrsMatrix::insertGlobalValues(const GlobalOrdinal globalRow, const Teuchos::ArrayView< const GlobalOrdinal > &cols, const Teuchos::ArrayView< const Scalar > &vals); %ignore Tpetra::CrsMatrix::insertLocalValues (const LocalOrdinal localRow, const Teuchos::ArrayView< const LocalOrdinal > &cols, const Teuchos::ArrayView< const Scalar > &vals); -%ignore Tpetra::CrsMatrix::getGlobalRowCopy(GlobalOrdinal GlobalRow, const Teuchos::ArrayView< GlobalOrdinal > &Indices, const Teuchos::ArrayView< Scalar > &Values, size_t &NumEntries) const; -%ignore Tpetra::CrsMatrix::replaceGlobalValues(const GlobalOrdinal globalRow, const Teuchos::ArrayView< const GlobalOrdinal > &cols, const Teuchos::ArrayView< const Scalar > &vals) const; %ignore Tpetra::CrsMatrix::replaceLocalValues(const LocalOrdinal localRow, const Teuchos::ArrayView< const LocalOrdinal > &cols, const Teuchos::ArrayView< const Scalar > &vals) const; %ignore Tpetra::CrsMatrix::sumIntoGlobalValues(const GlobalOrdinal globalRow, const Teuchos::ArrayView< const GlobalOrdinal > &cols, const Teuchos::ArrayView< const Scalar > &vals, const bool atomic=useAtomicUpdatesByDefault); %ignore Tpetra::CrsMatrix::setAllValues(const Teuchos::ArrayRCP< size_t > &ptr, const Teuchos::ArrayRCP< LocalOrdinal > &ind, const Teuchos::ArrayRCP< Scalar > &val); %ignore Tpetra::CrsMatrix::getAllValues(Teuchos::ArrayRCP< const size_t > &rowPointers, Teuchos::ArrayRCP< const LocalOrdinal > &columnIndices, Teuchos::ArrayRCP< const Scalar > &values) const; -%ignore Tpetra::CrsMatrix::getGlobalRowCopy(GlobalOrdinal GlobalRow, const Teuchos::ArrayView< GlobalOrdinal > &Indices, const Teuchos::ArrayView< Scalar > &Values, size_t &NumEntries) const; %ignore Tpetra::CrsMatrix::getLocalRowCopy(LocalOrdinal localRow, const Teuchos::ArrayView< LocalOrdinal > &colInds, const Teuchos::ArrayView< Scalar > &vals, size_t &numEntries) const; -%ignore Tpetra::CrsMatrix::getGlobalRowView(GlobalOrdinal GlobalRow, Teuchos::ArrayView< const GlobalOrdinal > &indices, Teuchos::ArrayView< const Scalar > &values) const; %ignore Tpetra::CrsMatrix::getLocalRowView(LocalOrdinal LocalRow, Teuchos::ArrayView< const LocalOrdinal > &indices, Teuchos::ArrayView< const Scalar > &values) const; %ignore Tpetra::CrsMatrix::getLocalRowViewRaw(const LocalOrdinal lclRow, LocalOrdinal &numEnt, const LocalOrdinal *&lclColInds, const Scalar *&vals) const; %ignore Tpetra::CrsMatrix::getAllValues (Teuchos::ArrayRCP& rowPointers, Teuchos::ArrayRCP& columnIndices, Teuchos::ArrayRCP& values) const; diff --git a/src/tpetra/src/Tpetra_Export.i b/src/tpetra/src/Tpetra_Export.i index d678fa76..1a6b2afd 100644 --- a/src/tpetra/src/Tpetra_Export.i +++ b/src/tpetra/src/Tpetra_Export.i @@ -22,12 +22,12 @@ using Tpetra::Import; // ======================================================================= // Postpone temporarily // ======================================================================= -%ignore Tpetra::Export::Export(const Teuchos::RCP< const map_type > &source, \ - const Teuchos::RCP< const map_type > &target, \ +%ignore Tpetra::Export::Export(const Teuchos::RCP< const map_type > &source, + const Teuchos::RCP< const map_type > &target, const Teuchos::RCP< Teuchos::FancyOStream > &out); // needs Teuchos::FancyOStream -%ignore Tpetra::Export::Export(const Teuchos::RCP< const map_type > &source, \ - const Teuchos::RCP< const map_type > &target, \ - const Teuchos::RCP< Teuchos::FancyOStream > &out, \ +%ignore Tpetra::Export::Export(const Teuchos::RCP< const map_type > &source, + const Teuchos::RCP< const map_type > &target, + const Teuchos::RCP< Teuchos::FancyOStream > &out, const Teuchos::RCP< Teuchos::ParameterList > &plist); // needs Teuchos::FancyOStream %ignore Tpetra::Export::getPermuteFromLIDs; // ±1 issue %ignore Tpetra::Export::getPermuteToLIDs; // ±1 issue diff --git a/src/tpetra/src/Tpetra_MultiVector.i b/src/tpetra/src/Tpetra_MultiVector.i index 3e3796d4..4601410f 100644 --- a/src/tpetra/src/Tpetra_MultiVector.i +++ b/src/tpetra/src/Tpetra_MultiVector.i @@ -66,25 +66,6 @@ %ignore Tpetra::getMultiVectorWhichVectors; %extend Tpetra::MultiVector { - Teuchos::RCP > subCopy(std::pair cols) const { - Teuchos::Array colsArray(cols.second); - for (int i = 0; i < colsArray.size(); i++) - colsArray[i] = cols.first[i]-1; - return self->subCopy(colsArray); - } - Teuchos::RCP > subView(std::pair cols) const { - Teuchos::Array colsArray(cols.second); - for (int i = 0; i < colsArray.size(); i++) - colsArray[i] = cols.first[i]-1; - return self->subView(colsArray); - } - Teuchos::RCP > subViewNonConst(std::pair cols) { - Teuchos::Array colsArray(cols.second); - for (int i = 0; i < colsArray.size(); i++) - colsArray[i] = cols.first[i]-1; - return self->subViewNonConst(colsArray); - } - void doImport (const Tpetra::MultiVector &source, const Tpetra::Import< LO, GO, NO > &importer, CombineMode CM) { self->doImport(source, importer, CM); } @@ -99,15 +80,9 @@ } } -%ignore Tpetra::MultiVector::subCopy(const Teuchos::ArrayView< const size_t > &cols) const; -%ignore Tpetra::MultiVector::subView(const Teuchos::ArrayView< const size_t > &cols) const; -%ignore Tpetra::MultiVector::subViewNonConst(const Teuchos::ArrayView< const size_t > &cols); - // Fix ±1 issues -// ======================================================================= -%typemap(in) size_t j %{$1 = *$input - 1;%} -%typemap(in) size_t col %{$1 = *$input - 1;%} -%typemap(in) int lclRow %{$1 = *$input - 1;%} /* int = LocalOrdinal */ +%apply int INDEX { size_t j, size_t col, int lclRow } +%apply const Teuchos::ArrayView& INDEX { const Teuchos::ArrayView& cols } /* Include the multivector *before* the RCP declaration so that * SWIG becomes aware of the default template arguments */ diff --git a/src/tpetra/src/fortpetra.i b/src/tpetra/src/fortpetra.i index 63f86b7e..d745b05d 100644 --- a/src/tpetra/src/fortpetra.i +++ b/src/tpetra/src/fortpetra.i @@ -32,7 +32,7 @@ typedef char Packet; %} // NOTE: with the latest SWIG, these will *not* show up in downstream -// %imported modules even if %insert is replaced with %fragment. +// %imported modules. %insert("fuse") { use, intrinsic :: iso_c_binding, only : & c_bool, & @@ -59,6 +59,29 @@ public :: mag_type public :: norm_type } +// Define typemap for converting Fortran indexing to C indexing +%typemap(in) int INDEX "$1 = *$input - 1;" +%typemap(out) int INDEX "$result = $1 + 1;" + +%fragment("", "header") %{ +#include +%} + +%typemap(in, fragment="", noblock=1) const Teuchos::ArrayView& INDEX + ($1_basetype::value_type* tmpbegin, + Teuchos::Array::type> tmparr, + $1_basetype tmpview) +{ + tmpbegin = static_cast<$1_basetype::value_type*>($input->data); + tmparr.resize($input->size); + for (int i = 0; i < tmparr.size(); i++) + tmparr[i] = tmpbegin[i] - 1; + tmpview = tmparr(); + + // Make the input argument point to our temporary vector + $1 = &tmpview; +} + // All enums should be prefaced with Tpetra %rename("Tpetra%s", %$isenumitem) ""; %rename("Tpetra%s", %$isenum) ""; @@ -66,7 +89,7 @@ public :: norm_type %include "Tpetra_ConfigDefs.i" -// ignore indexBase (Map, CrsGraph, CrsMatrix) +// Ignore indexBase (Map, CrsGraph, CrsMatrix) %ignore getIndexBase; // Order matters!!! diff --git a/src/tpetra/src/swig/fortpetra.F90 b/src/tpetra/src/swig/fortpetra.F90 index 8a2a29af..04b10164 100644 --- a/src/tpetra/src/swig/fortpetra.F90 +++ b/src/tpetra/src/swig/fortpetra.F90 @@ -234,6 +234,9 @@ module fortpetra procedure, private :: randomize__SWIG_1 => swigf_TpetraMultiVector_randomize__SWIG_1 procedure :: replaceMap => swigf_TpetraMultiVector_replaceMap procedure :: reduce => swigf_TpetraMultiVector_reduce + procedure :: subCopy => swigf_TpetraMultiVector_subCopy + procedure :: subView => swigf_TpetraMultiVector_subView + procedure :: subViewNonConst => swigf_TpetraMultiVector_subViewNonConst procedure :: offsetView => swigf_TpetraMultiVector_offsetView procedure :: offsetViewNonConst => swigf_TpetraMultiVector_offsetViewNonConst procedure :: getData => swigf_TpetraMultiVector_getData @@ -274,9 +277,6 @@ module fortpetra procedure :: setCopyOrView => swigf_TpetraMultiVector_setCopyOrView procedure :: getCopyOrView => swigf_TpetraMultiVector_getCopyOrView procedure :: isSameSize => swigf_TpetraMultiVector_isSameSize - procedure :: subCopy => swigf_TpetraMultiVector_subCopy - procedure :: subView => swigf_TpetraMultiVector_subView - procedure :: subViewNonConst => swigf_TpetraMultiVector_subViewNonConst procedure, private :: doImport__SWIG_0 => swigf_TpetraMultiVector_doImport__SWIG_0 procedure, private :: doImport__SWIG_1 => swigf_TpetraMultiVector_doImport__SWIG_1 procedure, private :: doExport__SWIG_0 => swigf_TpetraMultiVector_doExport__SWIG_0 @@ -416,6 +416,7 @@ module fortpetra procedure :: isSorted => swigf_TpetraCrsGraph_isSorted procedure :: isStorageOptimized => swigf_TpetraCrsGraph_isStorageOptimized procedure :: getProfileType => swigf_TpetraCrsGraph_getProfileType + procedure :: getGlobalRowCopy => swigf_TpetraCrsGraph_getGlobalRowCopy procedure :: supportsRowViews => swigf_TpetraCrsGraph_supportsRowViews procedure :: description => swigf_TpetraCrsGraph_description procedure :: replaceColMap => swigf_TpetraCrsGraph_replaceColMap @@ -436,13 +437,10 @@ module fortpetra procedure :: computeGlobalConstants => swigf_TpetraCrsGraph_computeGlobalConstants procedure, private :: insertGlobalIndices__SWIG_1 => swigf_TpetraCrsGraph_insertGlobalIndices__SWIG_1 procedure :: insertLocalIndices => swigf_TpetraCrsGraph_insertLocalIndices - procedure :: getGlobalRowCopy => swigf_TpetraCrsGraph_getGlobalRowCopy procedure :: getLocalRowCopy => swigf_TpetraCrsGraph_getLocalRowCopy - procedure :: getGlobalRowView => swigf_TpetraCrsGraph_getGlobalRowView procedure :: setAllIndices => swigf_TpetraCrsGraph_setAllIndices procedure :: getNodeRowPtrs => swigf_TpetraCrsGraph_getNodeRowPtrs procedure :: getNodePackedIndices => swigf_TpetraCrsGraph_getNodePackedIndices - procedure :: getLocalDiagOffsets => swigf_TpetraCrsGraph_getLocalDiagOffsets procedure, private :: doImport__SWIG_0 => swigf_TpetraCrsGraph_doImport__SWIG_0 procedure, private :: doImport__SWIG_1 => swigf_TpetraCrsGraph_doImport__SWIG_1 procedure, private :: doExport__SWIG_0 => swigf_TpetraCrsGraph_doExport__SWIG_0 @@ -481,11 +479,19 @@ module fortpetra type, public :: SWIGTYPE_KokkosSparse__CrsMatrixT_Tpetra__CrsMatrixT_doub1E12GN type(SwigClassWrapper), public :: swigdata end type + type, public :: SWIGTYPE_Teuchos__ArrayViewT_long_long_const_t + type(SwigClassWrapper), public :: swigdata + end type + type, public :: SWIGTYPE_Teuchos__ArrayViewT_double_const_t + type(SwigClassWrapper), public :: swigdata + end type ! class Tpetra::CrsMatrix< SC,LO,GO,NO > type, public :: TpetraCrsMatrix type(SwigClassWrapper), public :: swigdata contains procedure :: release => delete_TpetraCrsMatrix + procedure :: insertGlobalValues => swigf_TpetraCrsMatrix_insertGlobalValues + procedure :: replaceGlobalValues => swigf_TpetraCrsMatrix_replaceGlobalValues procedure :: setAllToScalar => swigf_TpetraCrsMatrix_setAllToScalar procedure :: scale => swigf_TpetraCrsMatrix_scale procedure :: globalAssemble => swigf_TpetraCrsMatrix_globalAssemble @@ -533,6 +539,8 @@ module fortpetra procedure :: isStaticGraph => swigf_TpetraCrsMatrix_isStaticGraph procedure :: getFrobeniusNorm => swigf_TpetraCrsMatrix_getFrobeniusNorm procedure :: supportsRowViews => swigf_TpetraCrsMatrix_supportsRowViews + procedure :: getGlobalRowCopy => swigf_TpetraCrsMatrix_getGlobalRowCopy + procedure :: getGlobalRowView => swigf_TpetraCrsMatrix_getGlobalRowView procedure, private :: apply__SWIG_0 => swigf_TpetraCrsMatrix_apply__SWIG_0 procedure, private :: apply__SWIG_1 => swigf_TpetraCrsMatrix_apply__SWIG_1 procedure, private :: apply__SWIG_2 => swigf_TpetraCrsMatrix_apply__SWIG_2 @@ -553,16 +561,11 @@ module fortpetra procedure, private :: exportAndFillComplete__SWIG_4 => swigf_TpetraCrsMatrix_exportAndFillComplete__SWIG_4 procedure :: computeGlobalConstants => swigf_TpetraCrsMatrix_computeGlobalConstants procedure :: haveGlobalConstants => swigf_TpetraCrsMatrix_haveGlobalConstants - procedure :: insertGlobalValues => swigf_TpetraCrsMatrix_insertGlobalValues procedure :: insertLocalValues => swigf_TpetraCrsMatrix_insertLocalValues - procedure :: replaceGlobalValues => swigf_TpetraCrsMatrix_replaceGlobalValues procedure :: sumIntoGlobalValues => swigf_TpetraCrsMatrix_sumIntoGlobalValues procedure :: setAllValues => swigf_TpetraCrsMatrix_setAllValues procedure :: getAllValues => swigf_TpetraCrsMatrix_getAllValues - procedure :: getGlobalRowCopy => swigf_TpetraCrsMatrix_getGlobalRowCopy procedure :: getLocalRowCopy => swigf_TpetraCrsMatrix_getLocalRowCopy - procedure :: getGlobalRowView => swigf_TpetraCrsMatrix_getGlobalRowView - procedure :: getLocalDiagOffsets => swigf_TpetraCrsMatrix_getLocalDiagOffsets procedure, private :: doImport__SWIG_0 => swigf_TpetraCrsMatrix_doImport__SWIG_0 procedure, private :: doImport__SWIG_1 => swigf_TpetraCrsMatrix_doImport__SWIG_1 procedure, private :: doExport__SWIG_0 => swigf_TpetraCrsMatrix_doExport__SWIG_0 @@ -1515,6 +1518,39 @@ subroutine swigc_TpetraMultiVector_reduce(farg1) & type(SwigClassWrapper) :: farg1 end subroutine +function swigc_TpetraMultiVector_subCopy(farg1, farg2) & +bind(C, name="_wrap_TpetraMultiVector_subCopy") & +result(fresult) +use, intrinsic :: ISO_C_BINDING +import :: swigclasswrapper +import :: swigarraywrapper +type(SwigClassWrapper) :: farg1 +type(SwigArrayWrapper) :: farg2 +type(SwigClassWrapper) :: fresult +end function + +function swigc_TpetraMultiVector_subView(farg1, farg2) & +bind(C, name="_wrap_TpetraMultiVector_subView") & +result(fresult) +use, intrinsic :: ISO_C_BINDING +import :: swigclasswrapper +import :: swigarraywrapper +type(SwigClassWrapper) :: farg1 +type(SwigArrayWrapper) :: farg2 +type(SwigClassWrapper) :: fresult +end function + +function swigc_TpetraMultiVector_subViewNonConst(farg1, farg2) & +bind(C, name="_wrap_TpetraMultiVector_subViewNonConst") & +result(fresult) +use, intrinsic :: ISO_C_BINDING +import :: swigclasswrapper +import :: swigarraywrapper +type(SwigClassWrapper) :: farg1 +type(SwigArrayWrapper) :: farg2 +type(SwigClassWrapper) :: fresult +end function + function swigc_TpetraMultiVector_offsetView(farg1, farg2, farg3) & bind(C, name="_wrap_TpetraMultiVector_offsetView") & result(fresult) @@ -1881,39 +1917,6 @@ function swigc_TpetraMultiVector_isSameSize(farg1, farg2) & integer(C_INT) :: fresult end function -function swigc_TpetraMultiVector_subCopy(farg1, farg2) & -bind(C, name="_wrap_TpetraMultiVector_subCopy") & -result(fresult) -use, intrinsic :: ISO_C_BINDING -import :: swigclasswrapper -import :: swigarraywrapper -type(SwigClassWrapper) :: farg1 -type(SwigArrayWrapper) :: farg2 -type(SwigClassWrapper) :: fresult -end function - -function swigc_TpetraMultiVector_subView(farg1, farg2) & -bind(C, name="_wrap_TpetraMultiVector_subView") & -result(fresult) -use, intrinsic :: ISO_C_BINDING -import :: swigclasswrapper -import :: swigarraywrapper -type(SwigClassWrapper) :: farg1 -type(SwigArrayWrapper) :: farg2 -type(SwigClassWrapper) :: fresult -end function - -function swigc_TpetraMultiVector_subViewNonConst(farg1, farg2) & -bind(C, name="_wrap_TpetraMultiVector_subViewNonConst") & -result(fresult) -use, intrinsic :: ISO_C_BINDING -import :: swigclasswrapper -import :: swigarraywrapper -type(SwigClassWrapper) :: farg1 -type(SwigArrayWrapper) :: farg2 -type(SwigClassWrapper) :: fresult -end function - subroutine swigc_TpetraMultiVector_doImport__SWIG_0(farg1, farg2, farg3, farg4) & bind(C, name="_wrap_TpetraMultiVector_doImport__SWIG_0") use, intrinsic :: ISO_C_BINDING @@ -2653,6 +2656,17 @@ function swigc_TpetraCrsGraph_getProfileType(farg1) & integer(C_INT) :: fresult end function +subroutine swigc_TpetraCrsGraph_getGlobalRowCopy(farg1, farg2, farg3, farg4) & +bind(C, name="_wrap_TpetraCrsGraph_getGlobalRowCopy") +use, intrinsic :: ISO_C_BINDING +import :: swigclasswrapper +import :: swigarraywrapper +type(SwigClassWrapper) :: farg1 +integer(C_LONG_LONG), intent(in) :: farg2 +type(SwigArrayWrapper) :: farg3 +type(C_PTR), value :: farg4 +end subroutine + function swigc_TpetraCrsGraph_supportsRowViews(farg1) & bind(C, name="_wrap_TpetraCrsGraph_supportsRowViews") & result(fresult) @@ -2954,17 +2968,6 @@ subroutine swigc_TpetraCrsGraph_insertLocalIndices(farg1, farg2, farg3) & type(SwigArrayWrapper) :: farg3 end subroutine -subroutine swigc_TpetraCrsGraph_getGlobalRowCopy(farg1, farg2, farg3, farg4) & -bind(C, name="_wrap_TpetraCrsGraph_getGlobalRowCopy") -use, intrinsic :: ISO_C_BINDING -import :: swigclasswrapper -import :: swigarraywrapper -type(SwigClassWrapper) :: farg1 -integer(C_LONG_LONG), intent(in) :: farg2 -type(SwigArrayWrapper) :: farg3 -type(C_PTR), value :: farg4 -end subroutine - subroutine swigc_TpetraCrsGraph_getLocalRowCopy(farg1, farg2, farg3, farg4) & bind(C, name="_wrap_TpetraCrsGraph_getLocalRowCopy") use, intrinsic :: ISO_C_BINDING @@ -2976,16 +2979,6 @@ subroutine swigc_TpetraCrsGraph_getLocalRowCopy(farg1, farg2, farg3, farg4) & type(C_PTR), value :: farg4 end subroutine -subroutine swigc_TpetraCrsGraph_getGlobalRowView(farg1, farg2, farg3) & -bind(C, name="_wrap_TpetraCrsGraph_getGlobalRowView") -use, intrinsic :: ISO_C_BINDING -import :: swigclasswrapper -import :: swigarraywrapper -type(SwigClassWrapper) :: farg1 -integer(C_LONG_LONG), intent(in) :: farg2 -type(SwigArrayWrapper) :: farg3 -end subroutine - subroutine swigc_TpetraCrsGraph_setAllIndices(farg1, farg2, farg3, farg4) & bind(C, name="_wrap_TpetraCrsGraph_setAllIndices") use, intrinsic :: ISO_C_BINDING @@ -3015,15 +3008,6 @@ subroutine swigc_TpetraCrsGraph_getNodePackedIndices(farg1, farg2) & type(SwigArrayWrapper) :: farg2 end subroutine -subroutine swigc_TpetraCrsGraph_getLocalDiagOffsets(farg1, farg2) & -bind(C, name="_wrap_TpetraCrsGraph_getLocalDiagOffsets") -use, intrinsic :: ISO_C_BINDING -import :: swigclasswrapper -import :: swigarraywrapper -type(SwigClassWrapper) :: farg1 -type(SwigArrayWrapper) :: farg2 -end subroutine - subroutine swigc_TpetraCrsGraph_doImport__SWIG_0(farg1, farg2, farg3, farg4) & bind(C, name="_wrap_TpetraCrsGraph_doImport__SWIG_0") use, intrinsic :: ISO_C_BINDING @@ -3187,6 +3171,30 @@ subroutine swigc_delete_TpetraCrsMatrix(farg1) & type(SwigClassWrapper) :: farg1 end subroutine +subroutine swigc_TpetraCrsMatrix_insertGlobalValues(farg1, farg2, farg3, farg4) & +bind(C, name="_wrap_TpetraCrsMatrix_insertGlobalValues") +use, intrinsic :: ISO_C_BINDING +import :: swigclasswrapper +import :: swigarraywrapper +type(SwigClassWrapper) :: farg1 +integer(C_LONG_LONG), intent(in) :: farg2 +type(SwigArrayWrapper) :: farg3 +type(SwigArrayWrapper) :: farg4 +end subroutine + +function swigc_TpetraCrsMatrix_replaceGlobalValues(farg1, farg2, farg3, farg4) & +bind(C, name="_wrap_TpetraCrsMatrix_replaceGlobalValues") & +result(fresult) +use, intrinsic :: ISO_C_BINDING +import :: swigclasswrapper +import :: swigarraywrapper +type(SwigClassWrapper) :: farg1 +integer(C_LONG_LONG), intent(in) :: farg2 +type(SwigArrayWrapper) :: farg3 +type(SwigArrayWrapper) :: farg4 +integer(C_INT) :: fresult +end function + subroutine swigc_TpetraCrsMatrix_setAllToScalar(farg1, farg2) & bind(C, name="_wrap_TpetraCrsMatrix_setAllToScalar") use, intrinsic :: ISO_C_BINDING @@ -3610,6 +3618,28 @@ function swigc_TpetraCrsMatrix_supportsRowViews(farg1) & integer(C_INT) :: fresult end function +subroutine swigc_TpetraCrsMatrix_getGlobalRowCopy(farg1, farg2, farg3, farg4, farg5) & +bind(C, name="_wrap_TpetraCrsMatrix_getGlobalRowCopy") +use, intrinsic :: ISO_C_BINDING +import :: swigclasswrapper +import :: swigarraywrapper +type(SwigClassWrapper) :: farg1 +integer(C_LONG_LONG), intent(in) :: farg2 +type(SwigArrayWrapper) :: farg3 +type(SwigArrayWrapper) :: farg4 +type(C_PTR), value :: farg5 +end subroutine + +subroutine swigc_TpetraCrsMatrix_getGlobalRowView(farg1, farg2, farg3, farg4) & +bind(C, name="_wrap_TpetraCrsMatrix_getGlobalRowView") +use, intrinsic :: ISO_C_BINDING +import :: swigclasswrapper +type(SwigClassWrapper) :: farg1 +integer(C_LONG_LONG), intent(in) :: farg2 +type(SwigClassWrapper) :: farg3 +type(SwigClassWrapper) :: farg4 +end subroutine + subroutine swigc_TpetraCrsMatrix_apply__SWIG_0(farg1, farg2, farg3, farg4, farg5, farg6) & bind(C, name="_wrap_TpetraCrsMatrix_apply__SWIG_0") use, intrinsic :: ISO_C_BINDING @@ -3927,17 +3957,6 @@ function swigc_new_TpetraCrsMatrix__SWIG_17(farg1, farg2, farg3, farg4, farg5) & type(SwigClassWrapper) :: fresult end function -subroutine swigc_TpetraCrsMatrix_insertGlobalValues(farg1, farg2, farg3, farg4) & -bind(C, name="_wrap_TpetraCrsMatrix_insertGlobalValues") -use, intrinsic :: ISO_C_BINDING -import :: swigclasswrapper -import :: swigarraywrapper -type(SwigClassWrapper) :: farg1 -integer(C_LONG_LONG), intent(in) :: farg2 -type(SwigArrayWrapper) :: farg3 -type(SwigArrayWrapper) :: farg4 -end subroutine - subroutine swigc_TpetraCrsMatrix_insertLocalValues(farg1, farg2, farg3, farg4) & bind(C, name="_wrap_TpetraCrsMatrix_insertLocalValues") use, intrinsic :: ISO_C_BINDING @@ -3949,19 +3968,6 @@ subroutine swigc_TpetraCrsMatrix_insertLocalValues(farg1, farg2, farg3, farg4) & type(SwigArrayWrapper) :: farg4 end subroutine -function swigc_TpetraCrsMatrix_replaceGlobalValues(farg1, farg2, farg3, farg4) & -bind(C, name="_wrap_TpetraCrsMatrix_replaceGlobalValues") & -result(fresult) -use, intrinsic :: ISO_C_BINDING -import :: swigclasswrapper -import :: swigarraywrapper -type(SwigClassWrapper) :: farg1 -integer(C_LONG_LONG), intent(in) :: farg2 -type(SwigArrayWrapper) :: farg3 -type(SwigArrayWrapper) :: farg4 -integer(C_INT) :: fresult -end function - function swigc_TpetraCrsMatrix_sumIntoGlobalValues(farg1, farg2, farg3, farg4) & bind(C, name="_wrap_TpetraCrsMatrix_sumIntoGlobalValues") & result(fresult) @@ -3997,18 +4003,6 @@ subroutine swigc_TpetraCrsMatrix_getAllValues(farg1, farg2, farg3, farg4) & type(SwigArrayWrapper) :: farg4 end subroutine -subroutine swigc_TpetraCrsMatrix_getGlobalRowCopy(farg1, farg2, farg3, farg4, farg5) & -bind(C, name="_wrap_TpetraCrsMatrix_getGlobalRowCopy") -use, intrinsic :: ISO_C_BINDING -import :: swigclasswrapper -import :: swigarraywrapper -type(SwigClassWrapper) :: farg1 -integer(C_LONG_LONG), intent(in) :: farg2 -type(SwigArrayWrapper) :: farg3 -type(SwigArrayWrapper) :: farg4 -type(C_PTR), value :: farg5 -end subroutine - subroutine swigc_TpetraCrsMatrix_getLocalRowCopy(farg1, farg2, farg3, farg4, farg5) & bind(C, name="_wrap_TpetraCrsMatrix_getLocalRowCopy") use, intrinsic :: ISO_C_BINDING @@ -4021,26 +4015,6 @@ subroutine swigc_TpetraCrsMatrix_getLocalRowCopy(farg1, farg2, farg3, farg4, far type(C_PTR), value :: farg5 end subroutine -subroutine swigc_TpetraCrsMatrix_getGlobalRowView(farg1, farg2, farg3, farg4) & -bind(C, name="_wrap_TpetraCrsMatrix_getGlobalRowView") -use, intrinsic :: ISO_C_BINDING -import :: swigclasswrapper -import :: swigarraywrapper -type(SwigClassWrapper) :: farg1 -integer(C_LONG_LONG), intent(in) :: farg2 -type(SwigArrayWrapper) :: farg3 -type(SwigArrayWrapper) :: farg4 -end subroutine - -subroutine swigc_TpetraCrsMatrix_getLocalDiagOffsets(farg1, farg2) & -bind(C, name="_wrap_TpetraCrsMatrix_getLocalDiagOffsets") -use, intrinsic :: ISO_C_BINDING -import :: swigclasswrapper -import :: swigarraywrapper -type(SwigClassWrapper) :: farg1 -type(SwigArrayWrapper) :: farg2 -end subroutine - subroutine swigc_TpetraCrsMatrix_doImport__SWIG_0(farg1, farg2, farg3, farg4) & bind(C, name="_wrap_TpetraCrsMatrix_doImport__SWIG_0") use, intrinsic :: ISO_C_BINDING @@ -6192,51 +6166,114 @@ subroutine swigf_TpetraMultiVector_reduce(self) call swigc_TpetraMultiVector_reduce(farg1) end subroutine -function swigf_TpetraMultiVector_offsetView(self, submap, offset) & +function swigf_TpetraMultiVector_subCopy(self, cols) & result(swig_result) use, intrinsic :: ISO_C_BINDING type(TpetraMultiVector) :: swig_result class(TpetraMultiVector), intent(in) :: self -class(TpetraMap), intent(in) :: submap - -integer(C_SIZE_T), intent(in) :: offset +integer(C_LONG), dimension(:), target :: cols +integer(C_LONG), pointer :: farg2_view type(SwigClassWrapper) :: fresult type(SwigClassWrapper) :: farg1 -type(SwigClassWrapper) :: farg2 -integer(C_SIZE_T) :: farg3 +type(SwigArrayWrapper) :: farg2 farg1 = self%swigdata -farg2 = submap%swigdata -farg3 = offset -fresult = swigc_TpetraMultiVector_offsetView(farg1, farg2, farg3) +farg2_view => cols(1) +farg2%data = c_loc(farg2_view) +farg2%size = size(cols) +fresult = swigc_TpetraMultiVector_subCopy(farg1, farg2) swig_result%swigdata = fresult end function -function swigf_TpetraMultiVector_offsetViewNonConst(self, submap, offset) & +function swigf_TpetraMultiVector_subView(self, cols) & result(swig_result) use, intrinsic :: ISO_C_BINDING type(TpetraMultiVector) :: swig_result -class(TpetraMultiVector), intent(inout) :: self - -class(TpetraMap), intent(in) :: submap +class(TpetraMultiVector), intent(in) :: self -integer(C_SIZE_T), intent(in) :: offset +integer(C_LONG), dimension(:), target :: cols +integer(C_LONG), pointer :: farg2_view type(SwigClassWrapper) :: fresult type(SwigClassWrapper) :: farg1 -type(SwigClassWrapper) :: farg2 -integer(C_SIZE_T) :: farg3 +type(SwigArrayWrapper) :: farg2 farg1 = self%swigdata -farg2 = submap%swigdata -farg3 = offset -fresult = swigc_TpetraMultiVector_offsetViewNonConst(farg1, farg2, farg3) +farg2_view => cols(1) +farg2%data = c_loc(farg2_view) +farg2%size = size(cols) +fresult = swigc_TpetraMultiVector_subView(farg1, farg2) swig_result%swigdata = fresult end function -function swigf_TpetraMultiVector_getData(self, j) & +function swigf_TpetraMultiVector_subViewNonConst(self, cols) & +result(swig_result) +use, intrinsic :: ISO_C_BINDING +type(TpetraMultiVector) :: swig_result +class(TpetraMultiVector), intent(inout) :: self + +integer(C_LONG), dimension(:), target :: cols +integer(C_LONG), pointer :: farg2_view + +type(SwigClassWrapper) :: fresult +type(SwigClassWrapper) :: farg1 +type(SwigArrayWrapper) :: farg2 + +farg1 = self%swigdata +farg2_view => cols(1) +farg2%data = c_loc(farg2_view) +farg2%size = size(cols) +fresult = swigc_TpetraMultiVector_subViewNonConst(farg1, farg2) +swig_result%swigdata = fresult +end function + +function swigf_TpetraMultiVector_offsetView(self, submap, offset) & +result(swig_result) +use, intrinsic :: ISO_C_BINDING +type(TpetraMultiVector) :: swig_result +class(TpetraMultiVector), intent(in) :: self + +class(TpetraMap), intent(in) :: submap + +integer(C_SIZE_T), intent(in) :: offset + +type(SwigClassWrapper) :: fresult +type(SwigClassWrapper) :: farg1 +type(SwigClassWrapper) :: farg2 +integer(C_SIZE_T) :: farg3 + +farg1 = self%swigdata +farg2 = submap%swigdata +farg3 = offset +fresult = swigc_TpetraMultiVector_offsetView(farg1, farg2, farg3) +swig_result%swigdata = fresult +end function + +function swigf_TpetraMultiVector_offsetViewNonConst(self, submap, offset) & +result(swig_result) +use, intrinsic :: ISO_C_BINDING +type(TpetraMultiVector) :: swig_result +class(TpetraMultiVector), intent(inout) :: self + +class(TpetraMap), intent(in) :: submap + +integer(C_SIZE_T), intent(in) :: offset + +type(SwigClassWrapper) :: fresult +type(SwigClassWrapper) :: farg1 +type(SwigClassWrapper) :: farg2 +integer(C_SIZE_T) :: farg3 + +farg1 = self%swigdata +farg2 = submap%swigdata +farg3 = offset +fresult = swigc_TpetraMultiVector_offsetViewNonConst(farg1, farg2, farg3) +swig_result%swigdata = fresult +end function + +function swigf_TpetraMultiVector_getData(self, j) & result(swig_result) use, intrinsic :: ISO_C_BINDING real(C_DOUBLE), dimension(:), pointer :: swig_result @@ -6838,69 +6875,6 @@ function swigf_TpetraMultiVector_isSameSize(self, vec) & swig_result = SWIG_int_to_logical(fresult) end function -function swigf_TpetraMultiVector_subCopy(self, cols) & -result(swig_result) -use, intrinsic :: ISO_C_BINDING -type(TpetraMultiVector) :: swig_result -class(TpetraMultiVector), intent(in) :: self - -integer(C_SIZE_T), dimension(:), target :: cols -integer(C_SIZE_T), pointer :: farg2_view - -type(SwigClassWrapper) :: fresult -type(SwigClassWrapper) :: farg1 -type(SwigArrayWrapper) :: farg2 - -farg1 = self%swigdata -farg2_view => cols(1) -farg2%data = c_loc(farg2_view) -farg2%size = size(cols) -fresult = swigc_TpetraMultiVector_subCopy(farg1, farg2) -swig_result%swigdata = fresult -end function - -function swigf_TpetraMultiVector_subView(self, cols) & -result(swig_result) -use, intrinsic :: ISO_C_BINDING -type(TpetraMultiVector) :: swig_result -class(TpetraMultiVector), intent(in) :: self - -integer(C_SIZE_T), dimension(:), target :: cols -integer(C_SIZE_T), pointer :: farg2_view - -type(SwigClassWrapper) :: fresult -type(SwigClassWrapper) :: farg1 -type(SwigArrayWrapper) :: farg2 - -farg1 = self%swigdata -farg2_view => cols(1) -farg2%data = c_loc(farg2_view) -farg2%size = size(cols) -fresult = swigc_TpetraMultiVector_subView(farg1, farg2) -swig_result%swigdata = fresult -end function - -function swigf_TpetraMultiVector_subViewNonConst(self, cols) & -result(swig_result) -use, intrinsic :: ISO_C_BINDING -type(TpetraMultiVector) :: swig_result -class(TpetraMultiVector), intent(inout) :: self - -integer(C_SIZE_T), dimension(:), target :: cols -integer(C_SIZE_T), pointer :: farg2_view - -type(SwigClassWrapper) :: fresult -type(SwigClassWrapper) :: farg1 -type(SwigArrayWrapper) :: farg2 - -farg1 = self%swigdata -farg2_view => cols(1) -farg2%data = c_loc(farg2_view) -farg2%size = size(cols) -fresult = swigc_TpetraMultiVector_subViewNonConst(farg1, farg2) -swig_result%swigdata = fresult -end function - subroutine swigf_TpetraMultiVector_doImport__SWIG_0(self, source, importer, cm) use, intrinsic :: ISO_C_BINDING class(TpetraMultiVector), intent(inout) :: self @@ -8293,6 +8267,29 @@ function swigf_TpetraCrsGraph_getProfileType(self) & swig_result = fresult end function +subroutine swigf_TpetraCrsGraph_getGlobalRowCopy(self, globalrow, indices, numindices) +use, intrinsic :: ISO_C_BINDING +class(TpetraCrsGraph), intent(in) :: self + +integer(C_LONG_LONG), intent(in) :: globalrow +integer(C_LONG_LONG), dimension(:), target :: indices +integer(C_LONG_LONG), pointer :: farg3_view +integer(C_SIZE_T), target, intent(inout) :: numindices + +type(SwigClassWrapper) :: farg1 +integer(C_LONG_LONG) :: farg2 +type(SwigArrayWrapper) :: farg3 +type(C_PTR) :: farg4 + +farg1 = self%swigdata +farg2 = globalrow +farg3_view => indices(1) +farg3%data = c_loc(farg3_view) +farg3%size = size(indices) +farg4 = c_loc(numindices) +call swigc_TpetraCrsGraph_getGlobalRowCopy(farg1, farg2, farg3, farg4) +end subroutine + function swigf_TpetraCrsGraph_supportsRowViews(self) & result(swig_result) use, intrinsic :: ISO_C_BINDING @@ -8678,8 +8675,8 @@ function new_TpetraCrsGraph__SWIG_6(rowmap, numentperrow, pftype, params) & type(TpetraCrsGraph) :: self class(TpetraMap), intent(in) :: rowmap -integer(C_SIZE_T), dimension(:), target :: numentperrow -integer(C_SIZE_T), pointer :: farg2_view +integer(C_LONG), dimension(:), target :: numentperrow +integer(C_LONG), pointer :: farg2_view integer(TpetraProfileType), intent(in) :: pftype class(ParameterList), intent(in) :: params @@ -8705,8 +8702,8 @@ function new_TpetraCrsGraph__SWIG_7(rowmap, numentperrow, pftype) & type(TpetraCrsGraph) :: self class(TpetraMap), intent(in) :: rowmap -integer(C_SIZE_T), dimension(:), target :: numentperrow -integer(C_SIZE_T), pointer :: farg2_view +integer(C_LONG), dimension(:), target :: numentperrow +integer(C_LONG), pointer :: farg2_view integer(TpetraProfileType), intent(in) :: pftype type(SwigClassWrapper) :: fresult @@ -8729,8 +8726,8 @@ function new_TpetraCrsGraph__SWIG_8(rowmap, numentperrow) & type(TpetraCrsGraph) :: self class(TpetraMap), intent(in) :: rowmap -integer(C_SIZE_T), dimension(:), target :: numentperrow -integer(C_SIZE_T), pointer :: farg2_view +integer(C_LONG), dimension(:), target :: numentperrow +integer(C_LONG), pointer :: farg2_view type(SwigClassWrapper) :: fresult type(SwigClassWrapper) :: farg1 @@ -8752,8 +8749,8 @@ function new_TpetraCrsGraph__SWIG_9(rowmap, colmap, numentperrow, pftype, params class(TpetraMap), intent(in) :: colmap -integer(C_SIZE_T), dimension(:), target :: numentperrow -integer(C_SIZE_T), pointer :: farg3_view +integer(C_LONG), dimension(:), target :: numentperrow +integer(C_LONG), pointer :: farg3_view integer(TpetraProfileType), intent(in) :: pftype class(ParameterList), intent(in) :: params @@ -8783,8 +8780,8 @@ function new_TpetraCrsGraph__SWIG_10(rowmap, colmap, numentperrow, pftype) & class(TpetraMap), intent(in) :: colmap -integer(C_SIZE_T), dimension(:), target :: numentperrow -integer(C_SIZE_T), pointer :: farg3_view +integer(C_LONG), dimension(:), target :: numentperrow +integer(C_LONG), pointer :: farg3_view integer(TpetraProfileType), intent(in) :: pftype type(SwigClassWrapper) :: fresult @@ -8811,8 +8808,8 @@ function new_TpetraCrsGraph__SWIG_11(rowmap, colmap, numentperrow) & class(TpetraMap), intent(in) :: colmap -integer(C_SIZE_T), dimension(:), target :: numentperrow -integer(C_SIZE_T), pointer :: farg3_view +integer(C_LONG), dimension(:), target :: numentperrow +integer(C_LONG), pointer :: farg3_view type(SwigClassWrapper) :: fresult type(SwigClassWrapper) :: farg1 @@ -8836,8 +8833,8 @@ function new_TpetraCrsGraph__SWIG_12(rowmap, colmap, rowpointers, columnindices, class(TpetraMap), intent(in) :: colmap -integer(C_SIZE_T), dimension(:), target :: rowpointers -integer(C_SIZE_T), pointer :: farg3_view +integer(C_LONG), dimension(:), target :: rowpointers +integer(C_LONG), pointer :: farg3_view integer(C_INT), dimension(:), target :: columnindices integer(C_INT), pointer :: farg4_view class(ParameterList), intent(in) :: params @@ -8870,8 +8867,8 @@ function new_TpetraCrsGraph__SWIG_13(rowmap, colmap, rowpointers, columnindices) class(TpetraMap), intent(in) :: colmap -integer(C_SIZE_T), dimension(:), target :: rowpointers -integer(C_SIZE_T), pointer :: farg3_view +integer(C_LONG), dimension(:), target :: rowpointers +integer(C_LONG), pointer :: farg3_view integer(C_INT), dimension(:), target :: columnindices integer(C_INT), pointer :: farg4_view @@ -8893,12 +8890,12 @@ function new_TpetraCrsGraph__SWIG_13(rowmap, colmap, rowpointers, columnindices) self%swigdata = fresult end function -subroutine swigf_TpetraCrsGraph_insertGlobalIndices__SWIG_1(self, globalrow, indices) +subroutine swigf_TpetraCrsGraph_insertGlobalIndices__SWIG_1(self, globalrow, indicesview) use, intrinsic :: ISO_C_BINDING class(TpetraCrsGraph), intent(inout) :: self integer(C_LONG_LONG), intent(in) :: globalrow -integer(C_LONG_LONG), dimension(:), target :: indices +integer(C_LONG_LONG), dimension(:), target :: indicesview integer(C_LONG_LONG), pointer :: farg3_view type(SwigClassWrapper) :: farg1 @@ -8907,9 +8904,9 @@ subroutine swigf_TpetraCrsGraph_insertGlobalIndices__SWIG_1(self, globalrow, ind farg1 = self%swigdata farg2 = globalrow -farg3_view => indices(1) +farg3_view => indicesview(1) farg3%data = c_loc(farg3_view) -farg3%size = size(indices) +farg3%size = size(indicesview) call swigc_TpetraCrsGraph_insertGlobalIndices__SWIG_1(farg1, farg2, farg3) end subroutine @@ -8933,35 +8930,12 @@ subroutine swigf_TpetraCrsGraph_insertLocalIndices(self, localrow, indices) call swigc_TpetraCrsGraph_insertLocalIndices(farg1, farg2, farg3) end subroutine -subroutine swigf_TpetraCrsGraph_getGlobalRowCopy(self, globalrow, indices, numindices) -use, intrinsic :: ISO_C_BINDING -class(TpetraCrsGraph), intent(in) :: self - -integer(C_LONG_LONG), intent(in) :: globalrow -integer(C_LONG_LONG), dimension(:), target :: indices -integer(C_LONG_LONG), pointer :: farg3_view -integer(C_SIZE_T), target, intent(inout) :: numindices - -type(SwigClassWrapper) :: farg1 -integer(C_LONG_LONG) :: farg2 -type(SwigArrayWrapper) :: farg3 -type(C_PTR) :: farg4 - -farg1 = self%swigdata -farg2 = globalrow -farg3_view => indices(1) -farg3%data = c_loc(farg3_view) -farg3%size = size(indices) -farg4 = c_loc(numindices) -call swigc_TpetraCrsGraph_getGlobalRowCopy(farg1, farg2, farg3, farg4) -end subroutine - -subroutine swigf_TpetraCrsGraph_getLocalRowCopy(self, localrow, indices, numindices) +subroutine swigf_TpetraCrsGraph_getLocalRowCopy(self, localrow, indicesview, numindices) use, intrinsic :: ISO_C_BINDING class(TpetraCrsGraph), intent(in) :: self integer, intent(in) :: localrow -integer(C_INT), dimension(:), target :: indices +integer(C_INT), dimension(:), target :: indicesview integer(C_INT), pointer :: farg3_view integer(C_SIZE_T), target, intent(inout) :: numindices @@ -8972,39 +8946,19 @@ subroutine swigf_TpetraCrsGraph_getLocalRowCopy(self, localrow, indices, numindi farg1 = self%swigdata farg2 = int(localrow, C_INT) -farg3_view => indices(1) +farg3_view => indicesview(1) farg3%data = c_loc(farg3_view) -farg3%size = size(indices) +farg3%size = size(indicesview) farg4 = c_loc(numindices) call swigc_TpetraCrsGraph_getLocalRowCopy(farg1, farg2, farg3, farg4) end subroutine -subroutine swigf_TpetraCrsGraph_getGlobalRowView(self, gblrow, lclcolinds) -use, intrinsic :: ISO_C_BINDING -class(TpetraCrsGraph), intent(in) :: self - -integer(C_LONG_LONG), intent(in) :: gblrow -integer(C_LONG_LONG), dimension(:), target :: lclcolinds -integer(C_LONG_LONG), pointer :: farg3_view - -type(SwigClassWrapper) :: farg1 -integer(C_LONG_LONG) :: farg2 -type(SwigArrayWrapper) :: farg3 - -farg1 = self%swigdata -farg2 = gblrow -farg3_view => lclcolinds(1) -farg3%data = c_loc(farg3_view) -farg3%size = size(lclcolinds) -call swigc_TpetraCrsGraph_getGlobalRowView(farg1, farg2, farg3) -end subroutine - subroutine swigf_TpetraCrsGraph_setAllIndices(self, rowpointers, columnindices, val) use, intrinsic :: ISO_C_BINDING class(TpetraCrsGraph), intent(inout) :: self -integer(C_SIZE_T), dimension(:), target :: rowpointers -integer(C_SIZE_T), pointer :: farg2_view +integer(C_LONG), dimension(:), target :: rowpointers +integer(C_LONG), pointer :: farg2_view integer(C_INT), dimension(:), target :: columnindices integer(C_INT), pointer :: farg3_view real(C_DOUBLE), dimension(:), target :: val @@ -9032,8 +8986,8 @@ subroutine swigf_TpetraCrsGraph_getNodeRowPtrs(self, rowpointers) use, intrinsic :: ISO_C_BINDING class(TpetraCrsGraph), intent(in) :: self -integer(C_SIZE_T), dimension(:), target :: rowpointers -integer(C_SIZE_T), pointer :: farg2_view +integer(C_LONG), dimension(:), target :: rowpointers +integer(C_LONG), pointer :: farg2_view type(SwigClassWrapper) :: farg1 type(SwigArrayWrapper) :: farg2 @@ -9049,8 +9003,8 @@ subroutine swigf_TpetraCrsGraph_getNodePackedIndices(self, columnindices) use, intrinsic :: ISO_C_BINDING class(TpetraCrsGraph), intent(in) :: self -integer(C_SIZE_T), dimension(:), target :: columnindices -integer(C_SIZE_T), pointer :: farg2_view +integer(C_LONG), dimension(:), target :: columnindices +integer(C_LONG), pointer :: farg2_view type(SwigClassWrapper) :: farg1 type(SwigArrayWrapper) :: farg2 @@ -9062,23 +9016,6 @@ subroutine swigf_TpetraCrsGraph_getNodePackedIndices(self, columnindices) call swigc_TpetraCrsGraph_getNodePackedIndices(farg1, farg2) end subroutine -subroutine swigf_TpetraCrsGraph_getLocalDiagOffsets(self, offsets) -use, intrinsic :: ISO_C_BINDING -class(TpetraCrsGraph), intent(in) :: self - -integer(C_SIZE_T), dimension(:), target :: offsets -integer(C_SIZE_T), pointer :: farg2_view - -type(SwigClassWrapper) :: farg1 -type(SwigArrayWrapper) :: farg2 - -farg1 = self%swigdata -farg2_view => offsets(1) -farg2%data = c_loc(farg2_view) -farg2%size = size(offsets) -call swigc_TpetraCrsGraph_getLocalDiagOffsets(farg1, farg2) -end subroutine - subroutine swigf_TpetraCrsGraph_doImport__SWIG_0(self, source, importer, cm) use, intrinsic :: ISO_C_BINDING class(TpetraCrsGraph), intent(inout) :: self @@ -9397,6 +9334,62 @@ subroutine delete_TpetraCrsMatrix(self) self%swigdata%mem = SWIG_NULL end subroutine +subroutine swigf_TpetraCrsMatrix_insertGlobalValues(self, globalrow, cols, vals) +use, intrinsic :: ISO_C_BINDING +class(TpetraCrsMatrix), intent(inout) :: self + +integer(C_LONG_LONG), intent(in) :: globalrow +integer(C_LONG_LONG), dimension(:), target :: cols +integer(C_LONG_LONG), pointer :: farg3_view +real(C_DOUBLE), dimension(:), target :: vals +real(C_DOUBLE), pointer :: farg4_view + +type(SwigClassWrapper) :: farg1 +integer(C_LONG_LONG) :: farg2 +type(SwigArrayWrapper) :: farg3 +type(SwigArrayWrapper) :: farg4 + +farg1 = self%swigdata +farg2 = globalrow +farg3_view => cols(1) +farg3%data = c_loc(farg3_view) +farg3%size = size(cols) +farg4_view => vals(1) +farg4%data = c_loc(farg4_view) +farg4%size = size(vals) +call swigc_TpetraCrsMatrix_insertGlobalValues(farg1, farg2, farg3, farg4) +end subroutine + +function swigf_TpetraCrsMatrix_replaceGlobalValues(self, globalrow, cols, vals) & +result(swig_result) +use, intrinsic :: ISO_C_BINDING +integer :: swig_result +class(TpetraCrsMatrix), intent(in) :: self + +integer(C_LONG_LONG), intent(in) :: globalrow +integer(C_LONG_LONG), dimension(:), target :: cols +integer(C_LONG_LONG), pointer :: farg3_view +real(C_DOUBLE), dimension(:), target :: vals +real(C_DOUBLE), pointer :: farg4_view + +integer(C_INT) :: fresult +type(SwigClassWrapper) :: farg1 +integer(C_LONG_LONG) :: farg2 +type(SwigArrayWrapper) :: farg3 +type(SwigArrayWrapper) :: farg4 + +farg1 = self%swigdata +farg2 = globalrow +farg3_view => cols(1) +farg3%data = c_loc(farg3_view) +farg3%size = size(cols) +farg4_view => vals(1) +farg4%data = c_loc(farg4_view) +farg4%size = size(vals) +fresult = swigc_TpetraCrsMatrix_replaceGlobalValues(farg1, farg2, farg3, farg4) +swig_result = int(fresult) +end function + subroutine swigf_TpetraCrsMatrix_setAllToScalar(self, alpha) use, intrinsic :: ISO_C_BINDING class(TpetraCrsMatrix), intent(inout) :: self @@ -10131,6 +10124,56 @@ function swigf_TpetraCrsMatrix_supportsRowViews(self) & swig_result = SWIG_int_to_logical(fresult) end function +subroutine swigf_TpetraCrsMatrix_getGlobalRowCopy(self, globalrow, indices, values, numentries) +use, intrinsic :: ISO_C_BINDING +class(TpetraCrsMatrix), intent(in) :: self + +integer(C_LONG_LONG), intent(in) :: globalrow +integer(C_LONG_LONG), dimension(:), target :: indices +integer(C_LONG_LONG), pointer :: farg3_view +real(C_DOUBLE), dimension(:), target :: values +real(C_DOUBLE), pointer :: farg4_view +integer(C_SIZE_T), target, intent(inout) :: numentries + +type(SwigClassWrapper) :: farg1 +integer(C_LONG_LONG) :: farg2 +type(SwigArrayWrapper) :: farg3 +type(SwigArrayWrapper) :: farg4 +type(C_PTR) :: farg5 + +farg1 = self%swigdata +farg2 = globalrow +farg3_view => indices(1) +farg3%data = c_loc(farg3_view) +farg3%size = size(indices) +farg4_view => values(1) +farg4%data = c_loc(farg4_view) +farg4%size = size(values) +farg5 = c_loc(numentries) +call swigc_TpetraCrsMatrix_getGlobalRowCopy(farg1, farg2, farg3, farg4, farg5) +end subroutine + +subroutine swigf_TpetraCrsMatrix_getGlobalRowView(self, globalrow, indices, values) +use, intrinsic :: ISO_C_BINDING +class(TpetraCrsMatrix), intent(in) :: self + +integer(C_LONG_LONG), intent(in) :: globalrow +class(SWIGTYPE_Teuchos__ArrayViewT_long_long_const_t), intent(inout) :: indices + +class(SWIGTYPE_Teuchos__ArrayViewT_double_const_t), intent(inout) :: values + +type(SwigClassWrapper) :: farg1 +integer(C_LONG_LONG) :: farg2 +type(SwigClassWrapper) :: farg3 +type(SwigClassWrapper) :: farg4 + +farg1 = self%swigdata +farg2 = globalrow +farg3 = indices%swigdata +farg4 = values%swigdata +call swigc_TpetraCrsMatrix_getGlobalRowView(farg1, farg2, farg3, farg4) +end subroutine + subroutine swigf_TpetraCrsMatrix_apply__SWIG_0(self, x, y, mode, alpha, beta) use, intrinsic :: ISO_C_BINDING class(TpetraCrsMatrix), intent(in) :: self @@ -10600,8 +10643,8 @@ function new_TpetraCrsMatrix__SWIG_10(rowmap, numentriesperrowtoalloc, pftype, p type(TpetraCrsMatrix) :: self class(TpetraMap), intent(in) :: rowmap -integer(C_SIZE_T), dimension(:), target :: numentriesperrowtoalloc -integer(C_SIZE_T), pointer :: farg2_view +integer(C_LONG), dimension(:), target :: numentriesperrowtoalloc +integer(C_LONG), pointer :: farg2_view integer(TpetraProfileType), intent(in) :: pftype class(ParameterList), intent(in) :: params @@ -10627,8 +10670,8 @@ function new_TpetraCrsMatrix__SWIG_11(rowmap, numentriesperrowtoalloc, pftype) & type(TpetraCrsMatrix) :: self class(TpetraMap), intent(in) :: rowmap -integer(C_SIZE_T), dimension(:), target :: numentriesperrowtoalloc -integer(C_SIZE_T), pointer :: farg2_view +integer(C_LONG), dimension(:), target :: numentriesperrowtoalloc +integer(C_LONG), pointer :: farg2_view integer(TpetraProfileType), intent(in) :: pftype type(SwigClassWrapper) :: fresult @@ -10651,8 +10694,8 @@ function new_TpetraCrsMatrix__SWIG_12(rowmap, numentriesperrowtoalloc) & type(TpetraCrsMatrix) :: self class(TpetraMap), intent(in) :: rowmap -integer(C_SIZE_T), dimension(:), target :: numentriesperrowtoalloc -integer(C_SIZE_T), pointer :: farg2_view +integer(C_LONG), dimension(:), target :: numentriesperrowtoalloc +integer(C_LONG), pointer :: farg2_view type(SwigClassWrapper) :: fresult type(SwigClassWrapper) :: farg1 @@ -10674,8 +10717,8 @@ function new_TpetraCrsMatrix__SWIG_13(rowmap, colmap, numentriesperrowtoalloc, p class(TpetraMap), intent(in) :: colmap -integer(C_SIZE_T), dimension(:), target :: numentriesperrowtoalloc -integer(C_SIZE_T), pointer :: farg3_view +integer(C_LONG), dimension(:), target :: numentriesperrowtoalloc +integer(C_LONG), pointer :: farg3_view integer(TpetraProfileType), intent(in) :: pftype class(ParameterList), intent(in) :: params @@ -10705,8 +10748,8 @@ function new_TpetraCrsMatrix__SWIG_14(rowmap, colmap, numentriesperrowtoalloc, p class(TpetraMap), intent(in) :: colmap -integer(C_SIZE_T), dimension(:), target :: numentriesperrowtoalloc -integer(C_SIZE_T), pointer :: farg3_view +integer(C_LONG), dimension(:), target :: numentriesperrowtoalloc +integer(C_LONG), pointer :: farg3_view integer(TpetraProfileType), intent(in) :: pftype type(SwigClassWrapper) :: fresult @@ -10733,8 +10776,8 @@ function new_TpetraCrsMatrix__SWIG_15(rowmap, colmap, numentriesperrowtoalloc) & class(TpetraMap), intent(in) :: colmap -integer(C_SIZE_T), dimension(:), target :: numentriesperrowtoalloc -integer(C_SIZE_T), pointer :: farg3_view +integer(C_LONG), dimension(:), target :: numentriesperrowtoalloc +integer(C_LONG), pointer :: farg3_view type(SwigClassWrapper) :: fresult type(SwigClassWrapper) :: farg1 @@ -10758,8 +10801,8 @@ function new_TpetraCrsMatrix__SWIG_16(rowmap, colmap, rowpointers, columnindices class(TpetraMap), intent(in) :: colmap -integer(C_SIZE_T), dimension(:), target :: rowpointers -integer(C_SIZE_T), pointer :: farg3_view +integer(C_LONG), dimension(:), target :: rowpointers +integer(C_LONG), pointer :: farg3_view integer(C_INT), dimension(:), target :: columnindices integer(C_INT), pointer :: farg4_view real(C_DOUBLE), dimension(:), target :: values @@ -10798,8 +10841,8 @@ function new_TpetraCrsMatrix__SWIG_17(rowmap, colmap, rowpointers, columnindices class(TpetraMap), intent(in) :: colmap -integer(C_SIZE_T), dimension(:), target :: rowpointers -integer(C_SIZE_T), pointer :: farg3_view +integer(C_LONG), dimension(:), target :: rowpointers +integer(C_LONG), pointer :: farg3_view integer(C_INT), dimension(:), target :: columnindices integer(C_INT), pointer :: farg4_view real(C_DOUBLE), dimension(:), target :: values @@ -10827,32 +10870,6 @@ function new_TpetraCrsMatrix__SWIG_17(rowmap, colmap, rowpointers, columnindices self%swigdata = fresult end function -subroutine swigf_TpetraCrsMatrix_insertGlobalValues(self, globalrow, cols, vals) -use, intrinsic :: ISO_C_BINDING -class(TpetraCrsMatrix), intent(inout) :: self - -integer(C_LONG_LONG), intent(in) :: globalrow -integer(C_LONG_LONG), dimension(:), target :: cols -integer(C_LONG_LONG), pointer :: farg3_view -real(C_DOUBLE), dimension(:), target :: vals -real(C_DOUBLE), pointer :: farg4_view - -type(SwigClassWrapper) :: farg1 -integer(C_LONG_LONG) :: farg2 -type(SwigArrayWrapper) :: farg3 -type(SwigArrayWrapper) :: farg4 - -farg1 = self%swigdata -farg2 = globalrow -farg3_view => cols(1) -farg3%data = c_loc(farg3_view) -farg3%size = size(cols) -farg4_view => vals(1) -farg4%data = c_loc(farg4_view) -farg4%size = size(vals) -call swigc_TpetraCrsMatrix_insertGlobalValues(farg1, farg2, farg3, farg4) -end subroutine - subroutine swigf_TpetraCrsMatrix_insertLocalValues(self, localrow, cols, vals) use, intrinsic :: ISO_C_BINDING class(TpetraCrsMatrix), intent(inout) :: self @@ -10879,36 +10896,6 @@ subroutine swigf_TpetraCrsMatrix_insertLocalValues(self, localrow, cols, vals) call swigc_TpetraCrsMatrix_insertLocalValues(farg1, farg2, farg3, farg4) end subroutine -function swigf_TpetraCrsMatrix_replaceGlobalValues(self, globalrow, cols, vals) & -result(swig_result) -use, intrinsic :: ISO_C_BINDING -integer :: swig_result -class(TpetraCrsMatrix), intent(in) :: self - -integer(C_LONG_LONG), intent(in) :: globalrow -integer(C_LONG_LONG), dimension(:), target :: cols -integer(C_LONG_LONG), pointer :: farg3_view -real(C_DOUBLE), dimension(:), target :: vals -real(C_DOUBLE), pointer :: farg4_view - -integer(C_INT) :: fresult -type(SwigClassWrapper) :: farg1 -integer(C_LONG_LONG) :: farg2 -type(SwigArrayWrapper) :: farg3 -type(SwigArrayWrapper) :: farg4 - -farg1 = self%swigdata -farg2 = globalrow -farg3_view => cols(1) -farg3%data = c_loc(farg3_view) -farg3%size = size(cols) -farg4_view => vals(1) -farg4%data = c_loc(farg4_view) -farg4%size = size(vals) -fresult = swigc_TpetraCrsMatrix_replaceGlobalValues(farg1, farg2, farg3, farg4) -swig_result = int(fresult) -end function - function swigf_TpetraCrsMatrix_sumIntoGlobalValues(self, globalrow, cols, vals) & result(swig_result) use, intrinsic :: ISO_C_BINDING @@ -10943,8 +10930,8 @@ subroutine swigf_TpetraCrsMatrix_setAllValues(self, ptr, ind, val) use, intrinsic :: ISO_C_BINDING class(TpetraCrsMatrix), intent(inout) :: self -integer(C_SIZE_T), dimension(:), target :: ptr -integer(C_SIZE_T), pointer :: farg2_view +integer(C_LONG), dimension(:), target :: ptr +integer(C_LONG), pointer :: farg2_view integer(C_INT), dimension(:), target :: ind integer(C_INT), pointer :: farg3_view real(C_DOUBLE), dimension(:), target :: val @@ -10972,8 +10959,8 @@ subroutine swigf_TpetraCrsMatrix_getAllValues(self, rowpointers, columnindices, use, intrinsic :: ISO_C_BINDING class(TpetraCrsMatrix), intent(in) :: self -integer(C_SIZE_T), dimension(:), target :: rowpointers -integer(C_SIZE_T), pointer :: farg2_view +integer(C_LONG), dimension(:), target :: rowpointers +integer(C_LONG), pointer :: farg2_view integer(C_INT), dimension(:), target :: columnindices integer(C_INT), pointer :: farg3_view real(C_DOUBLE), dimension(:), target :: values @@ -10997,35 +10984,6 @@ subroutine swigf_TpetraCrsMatrix_getAllValues(self, rowpointers, columnindices, call swigc_TpetraCrsMatrix_getAllValues(farg1, farg2, farg3, farg4) end subroutine -subroutine swigf_TpetraCrsMatrix_getGlobalRowCopy(self, globalrow, indices, values, numindices) -use, intrinsic :: ISO_C_BINDING -class(TpetraCrsMatrix), intent(in) :: self - -integer(C_LONG_LONG), intent(in) :: globalrow -integer(C_LONG_LONG), dimension(:), target :: indices -integer(C_LONG_LONG), pointer :: farg3_view -real(C_DOUBLE), dimension(:), target :: values -real(C_DOUBLE), pointer :: farg4_view -integer(C_SIZE_T), target, intent(inout) :: numindices - -type(SwigClassWrapper) :: farg1 -integer(C_LONG_LONG) :: farg2 -type(SwigArrayWrapper) :: farg3 -type(SwigArrayWrapper) :: farg4 -type(C_PTR) :: farg5 - -farg1 = self%swigdata -farg2 = globalrow -farg3_view => indices(1) -farg3%data = c_loc(farg3_view) -farg3%size = size(indices) -farg4_view => values(1) -farg4%data = c_loc(farg4_view) -farg4%size = size(values) -farg5 = c_loc(numindices) -call swigc_TpetraCrsMatrix_getGlobalRowCopy(farg1, farg2, farg3, farg4, farg5) -end subroutine - subroutine swigf_TpetraCrsMatrix_getLocalRowCopy(self, localrow, colinds, vals, numindices) use, intrinsic :: ISO_C_BINDING class(TpetraCrsMatrix), intent(in) :: self @@ -11055,49 +11013,6 @@ subroutine swigf_TpetraCrsMatrix_getLocalRowCopy(self, localrow, colinds, vals, call swigc_TpetraCrsMatrix_getLocalRowCopy(farg1, farg2, farg3, farg4, farg5) end subroutine -subroutine swigf_TpetraCrsMatrix_getGlobalRowView(self, globalrow, indices, values) -use, intrinsic :: ISO_C_BINDING -class(TpetraCrsMatrix), intent(in) :: self - -integer(C_LONG_LONG), intent(in) :: globalrow -integer(C_LONG_LONG), dimension(:), target :: indices -integer(C_LONG_LONG), pointer :: farg3_view -real(C_DOUBLE), dimension(:), target :: values -real(C_DOUBLE), pointer :: farg4_view - -type(SwigClassWrapper) :: farg1 -integer(C_LONG_LONG) :: farg2 -type(SwigArrayWrapper) :: farg3 -type(SwigArrayWrapper) :: farg4 - -farg1 = self%swigdata -farg2 = globalrow -farg3_view => indices(1) -farg3%data = c_loc(farg3_view) -farg3%size = size(indices) -farg4_view => values(1) -farg4%data = c_loc(farg4_view) -farg4%size = size(values) -call swigc_TpetraCrsMatrix_getGlobalRowView(farg1, farg2, farg3, farg4) -end subroutine - -subroutine swigf_TpetraCrsMatrix_getLocalDiagOffsets(self, offsets) -use, intrinsic :: ISO_C_BINDING -class(TpetraCrsMatrix), intent(in) :: self - -integer(C_SIZE_T), dimension(:), target :: offsets -integer(C_SIZE_T), pointer :: farg2_view - -type(SwigClassWrapper) :: farg1 -type(SwigArrayWrapper) :: farg2 - -farg1 = self%swigdata -farg2_view => offsets(1) -farg2%data = c_loc(farg2_view) -farg2%size = size(offsets) -call swigc_TpetraCrsMatrix_getLocalDiagOffsets(farg1, farg2) -end subroutine - subroutine swigf_TpetraCrsMatrix_doImport__SWIG_0(self, source, importer, cm) use, intrinsic :: ISO_C_BINDING class(TpetraCrsMatrix), intent(inout) :: self diff --git a/src/tpetra/src/swig/fortpetraFORTRAN_wrap.cxx b/src/tpetra/src/swig/fortpetraFORTRAN_wrap.cxx index 1b976fec..fbc21bcc 100644 --- a/src/tpetra/src/swig/fortpetraFORTRAN_wrap.cxx +++ b/src/tpetra/src/swig/fortpetraFORTRAN_wrap.cxx @@ -603,24 +603,9 @@ using Tpetra::Import; #include "Tpetra_MultiVector.hpp" -SWIGINTERN Teuchos::RCP< Tpetra::MultiVector< SC,LO,GO,NO > > Tpetra_MultiVector_Sl_SC_Sc_LO_Sc_GO_Sc_NO_Sg__subCopy(Tpetra::MultiVector< SC,LO,GO,NO > const *self,std::pair< std::size_t const *,std::size_t > cols){ - Teuchos::Array colsArray(cols.second); - for (int i = 0; i < colsArray.size(); i++) - colsArray[i] = cols.first[i]-1; - return self->subCopy(colsArray); - } -SWIGINTERN Teuchos::RCP< Tpetra::MultiVector< SC,LO,GO,NO > const > Tpetra_MultiVector_Sl_SC_Sc_LO_Sc_GO_Sc_NO_Sg__subView(Tpetra::MultiVector< SC,LO,GO,NO > const *self,std::pair< std::size_t const *,std::size_t > cols){ - Teuchos::Array colsArray(cols.second); - for (int i = 0; i < colsArray.size(); i++) - colsArray[i] = cols.first[i]-1; - return self->subView(colsArray); - } -SWIGINTERN Teuchos::RCP< Tpetra::MultiVector< SC,LO,GO,NO > > Tpetra_MultiVector_Sl_SC_Sc_LO_Sc_GO_Sc_NO_Sg__subViewNonConst(Tpetra::MultiVector< SC,LO,GO,NO > *self,std::pair< std::size_t const *,std::size_t > cols){ - Teuchos::Array colsArray(cols.second); - for (int i = 0; i < colsArray.size(); i++) - colsArray[i] = cols.first[i]-1; - return self->subViewNonConst(colsArray); - } + +#include + SWIGINTERN void Tpetra_MultiVector_Sl_SC_Sc_LO_Sc_GO_Sc_NO_Sg__doImport__SWIG_0(Tpetra::MultiVector< SC,LO,GO,NO > *self,Tpetra::MultiVector< SC,LO,GO,NO > const &source,Tpetra::Import< LO,GO,NO > const &importer,Tpetra::CombineMode CM){ self->doImport(source, importer, CM); } @@ -733,75 +718,58 @@ SwigClassWrapper swigd_ForTpetraOperator_getRangeMap( #include "Tpetra_CrsGraph.hpp" -SWIGINTERN Tpetra::CrsGraph< LO,GO,NO > *new_Tpetra_CrsGraph_Sl_LO_Sc_GO_Sc_NO_Sg___SWIG_6(Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &rowMap,std::pair< std::size_t const *,std::size_t > numEntPerRow,Tpetra::ProfileType const pftype=Tpetra::DynamicProfile,Teuchos::RCP< Teuchos::ParameterList > const ¶ms=Teuchos::null){ - Teuchos::ArrayRCP numEntPerRowRCP(numEntPerRow.first, 0, numEntPerRow.second, false/*has_ownership*/); - return new Tpetra::CrsGraph(rowMap, numEntPerRowRCP, pftype, params); - } -SWIGINTERN Tpetra::CrsGraph< LO,GO,NO > *new_Tpetra_CrsGraph_Sl_LO_Sc_GO_Sc_NO_Sg___SWIG_9(Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &rowMap,Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &colMap,std::pair< std::size_t const *,std::size_t > numEntPerRow,Tpetra::ProfileType const pftype=Tpetra::DynamicProfile,Teuchos::RCP< Teuchos::ParameterList > const ¶ms=Teuchos::null){ - Teuchos::ArrayRCP numEntPerRowRCP(numEntPerRow.first, 0, numEntPerRow.second, false/*has_ownership*/); - return new Tpetra::CrsGraph(rowMap, colMap, numEntPerRowRCP, pftype, params); - } -SWIGINTERN Tpetra::CrsGraph< LO,GO,NO > *new_Tpetra_CrsGraph_Sl_LO_Sc_GO_Sc_NO_Sg___SWIG_12(Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &rowMap,Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &colMap,std::pair< std::size_t *,std::size_t > rowPointers,std::pair< LO *,std::size_t > columnIndices,Teuchos::RCP< Teuchos::ParameterList > const ¶ms=Teuchos::null){ - Teuchos::Array rowPointersArray(rowPointers.second); - for (size_t i = 0; i < rowPointers.second; i++) - rowPointersArray[i] = rowPointers.first[i]-1; - Teuchos::Array columnIndicesArray(columnIndices.second); - for (size_t i = 0; i < columnIndices.second; i++) - columnIndicesArray[i] = columnIndices.first[i]-1; +SWIGINTERN Tpetra::CrsGraph< LO,GO,NO > *new_Tpetra_CrsGraph_Sl_LO_Sc_GO_Sc_NO_Sg___SWIG_6(Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &rowMap,Teuchos::ArrayView< std::size_t const > numEntPerRow,Tpetra::ProfileType const pftype=Tpetra::DynamicProfile,Teuchos::RCP< Teuchos::ParameterList > const ¶ms=Teuchos::null){ + return new Tpetra::CrsGraph(rowMap, arcpFromArrayView(numEntPerRow), pftype, params); + } +SWIGINTERN Tpetra::CrsGraph< LO,GO,NO > *new_Tpetra_CrsGraph_Sl_LO_Sc_GO_Sc_NO_Sg___SWIG_9(Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &rowMap,Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &colMap,Teuchos::ArrayView< std::size_t const > numEntPerRow,Tpetra::ProfileType const pftype=Tpetra::DynamicProfile,Teuchos::RCP< Teuchos::ParameterList > const ¶ms=Teuchos::null){ + return new Tpetra::CrsGraph(rowMap, colMap, arcpFromArrayView(numEntPerRow), pftype, params); + } +SWIGINTERN Tpetra::CrsGraph< LO,GO,NO > *new_Tpetra_CrsGraph_Sl_LO_Sc_GO_Sc_NO_Sg___SWIG_12(Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &rowMap,Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &colMap,Teuchos::ArrayView< std::size_t > rowPointers,Teuchos::ArrayView< LO > columnIndices,Teuchos::RCP< Teuchos::ParameterList > const ¶ms=Teuchos::null){ + Teuchos::Array rowPointersArray(rowPointers.size()); + for (size_t i = 0; i < rowPointers.size(); i++) + rowPointersArray[i] = rowPointers[i]-1; + Teuchos::Array columnIndicesArray(columnIndices.size()); + for (size_t i = 0; i < columnIndices.size(); i++) + columnIndicesArray[i] = columnIndices[i]-1; return new Tpetra::CrsGraph(rowMap, colMap, Teuchos::arcpFromArray(rowPointersArray), Teuchos::arcpFromArray(columnIndicesArray), params); } -SWIGINTERN void Tpetra_CrsGraph_Sl_LO_Sc_GO_Sc_NO_Sg__insertGlobalIndices__SWIG_1(Tpetra::CrsGraph< LO,GO,NO > *self,GO const globalRow,std::pair< GO const *,std::size_t > indices){ - Teuchos::ArrayView indicesView = Teuchos::arrayView(indices.first, indices.second); +SWIGINTERN void Tpetra_CrsGraph_Sl_LO_Sc_GO_Sc_NO_Sg__insertGlobalIndices__SWIG_1(Tpetra::CrsGraph< LO,GO,NO > *self,GO const globalRow,Teuchos::ArrayView< GO const > indicesView){ self->insertGlobalIndices(globalRow, indicesView); } -SWIGINTERN void Tpetra_CrsGraph_Sl_LO_Sc_GO_Sc_NO_Sg__insertLocalIndices(Tpetra::CrsGraph< LO,GO,NO > *self,LO const localRow,std::pair< LO const *,std::size_t > indices){ - Teuchos::Array indicesArray(indices.second); +SWIGINTERN void Tpetra_CrsGraph_Sl_LO_Sc_GO_Sc_NO_Sg__insertLocalIndices(Tpetra::CrsGraph< LO,GO,NO > *self,LO const localRow,Teuchos::ArrayView< LO const > indices){ + Teuchos::Array indicesArray(indices.size()); for (size_t i = 0; i < indicesArray.size(); i++) - indicesArray[i] = indices.first[i]-1; + indicesArray[i] = indices[i]-1; self->insertLocalIndices(localRow, indicesArray); } -SWIGINTERN void Tpetra_CrsGraph_Sl_LO_Sc_GO_Sc_NO_Sg__getGlobalRowCopy(Tpetra::CrsGraph< LO,GO,NO > const *self,GO GlobalRow,std::pair< GO *,std::size_t > Indices,size_t &NumIndices){ - Teuchos::ArrayView IndicesView = Teuchos::arrayView(Indices.first, Indices.second); - self->getGlobalRowCopy(GlobalRow, IndicesView, NumIndices); - } -SWIGINTERN void Tpetra_CrsGraph_Sl_LO_Sc_GO_Sc_NO_Sg__getLocalRowCopy(Tpetra::CrsGraph< LO,GO,NO > const *self,LO localRow,std::pair< LO *,std::size_t > indices,size_t &NumIndices){ - Teuchos::ArrayView indicesView = Teuchos::arrayView(indices.first, indices.second); +SWIGINTERN void Tpetra_CrsGraph_Sl_LO_Sc_GO_Sc_NO_Sg__getLocalRowCopy(Tpetra::CrsGraph< LO,GO,NO > const *self,LO localRow,Teuchos::ArrayView< LO > indicesView,size_t &NumIndices){ self->getLocalRowCopy(localRow, indicesView, NumIndices); for (int i = 0; i < indicesView.size(); i++) indicesView[i]++; } -SWIGINTERN void Tpetra_CrsGraph_Sl_LO_Sc_GO_Sc_NO_Sg__getGlobalRowView(Tpetra::CrsGraph< LO,GO,NO > const *self,GO const gblRow,std::pair< GO const *,std::size_t > lclColInds){ - Teuchos::ArrayView lclColIndsView = Teuchos::arrayView(lclColInds.first, lclColInds.second); - self->getGlobalRowView(gblRow, lclColIndsView); - } -SWIGINTERN void Tpetra_CrsGraph_Sl_LO_Sc_GO_Sc_NO_Sg__setAllIndices(Tpetra::CrsGraph< LO,GO,NO > *self,std::pair< std::size_t *,std::size_t > rowPointers,std::pair< LO *,std::size_t > columnIndices,std::pair< SC *,std::size_t > val){ - Teuchos::ArrayRCP rowPointersArrayRCP(rowPointers.second); +SWIGINTERN void Tpetra_CrsGraph_Sl_LO_Sc_GO_Sc_NO_Sg__setAllIndices(Tpetra::CrsGraph< LO,GO,NO > *self,Teuchos::ArrayView< std::size_t > rowPointers,Teuchos::ArrayView< LO > columnIndices,Teuchos::ArrayView< SC > val){ + Teuchos::ArrayRCP rowPointersArrayRCP(rowPointers.size()); for (int i = 0; i < rowPointersArrayRCP.size(); i++) - rowPointersArrayRCP[i] = rowPointers.first[i]-1; - Teuchos::ArrayRCP columnIndicesArrayRCP(columnIndices.second); + rowPointersArrayRCP[i] = rowPointers[i]-1; + Teuchos::ArrayRCP columnIndicesArrayRCP(columnIndices.size()); for (int i = 0; i < columnIndicesArrayRCP.size(); i++) - columnIndicesArrayRCP[i] = columnIndices.first[i]-1; + columnIndicesArrayRCP[i] = columnIndices[i]-1; self->setAllIndices(rowPointersArrayRCP, columnIndicesArrayRCP); } -SWIGINTERN void Tpetra_CrsGraph_Sl_LO_Sc_GO_Sc_NO_Sg__getNodeRowPtrs(Tpetra::CrsGraph< LO,GO,NO > const *self,std::pair< std::size_t *,std::size_t > rowPointers){ +SWIGINTERN void Tpetra_CrsGraph_Sl_LO_Sc_GO_Sc_NO_Sg__getNodeRowPtrs(Tpetra::CrsGraph< LO,GO,NO > const *self,Teuchos::ArrayView< std::size_t > rowPointers){ auto rowPointersArrayRCP = self->getNodeRowPtrs(); - TEUCHOS_TEST_FOR_EXCEPTION(rowPointersArrayRCP.size() != rowPointers.second, std::runtime_error, "Wrong rowPointers size"); - auto n = rowPointers.second; + TEUCHOS_TEST_FOR_EXCEPTION(rowPointersArrayRCP.size() != rowPointers.size(), std::runtime_error, "Wrong rowPointers size"); + auto n = rowPointers.size(); for (int i = 0; i < n; i++) - rowPointers.first[i] = rowPointersArrayRCP[i]+1; + rowPointers[i] = rowPointersArrayRCP[i]+1; } -SWIGINTERN void Tpetra_CrsGraph_Sl_LO_Sc_GO_Sc_NO_Sg__getNodePackedIndices(Tpetra::CrsGraph< LO,GO,NO > const *self,std::pair< std::size_t *,std::size_t > columnIndices){ +SWIGINTERN void Tpetra_CrsGraph_Sl_LO_Sc_GO_Sc_NO_Sg__getNodePackedIndices(Tpetra::CrsGraph< LO,GO,NO > const *self,Teuchos::ArrayView< std::size_t > columnIndices){ auto columnIndicesArrayRCP = self->getNodeRowPtrs(); - TEUCHOS_TEST_FOR_EXCEPTION(columnIndicesArrayRCP.size() != columnIndices.second, std::runtime_error, "Wrong columnIndices size"); - auto nnz = columnIndices.second; + TEUCHOS_TEST_FOR_EXCEPTION(columnIndicesArrayRCP.size() != columnIndices.size(), std::runtime_error, "Wrong columnIndices size"); + auto nnz = columnIndices.size(); for (int i = 0; i < nnz; i++) - columnIndices.first[i] = columnIndicesArrayRCP[i]+1; - } -SWIGINTERN void Tpetra_CrsGraph_Sl_LO_Sc_GO_Sc_NO_Sg__getLocalDiagOffsets(Tpetra::CrsGraph< LO,GO,NO > const *self,std::pair< std::size_t *,std::size_t > offsets){ - TEUCHOS_TEST_FOR_EXCEPTION(self->getNodeNumRows() != offsets.second, std::runtime_error, "Wrong offsets size"); - Teuchos::ArrayRCP offsetsArrayRCP(offsets.first, 0, offsets.second, false/*has_ownership*/); - self->getLocalDiagOffsets(offsetsArrayRCP); + columnIndices[i] = columnIndicesArrayRCP[i]+1; } SWIGINTERN void Tpetra_CrsGraph_Sl_LO_Sc_GO_Sc_NO_Sg__doImport__SWIG_0(Tpetra::CrsGraph< LO,GO,NO > *self,Tpetra::CrsGraph< LO,GO,NO > const &source,Tpetra::Import< LO,GO,NO > const &importer,Tpetra::CombineMode CM){ self->doImport(source, importer, CM); @@ -818,98 +786,63 @@ SWIGINTERN void Tpetra_CrsGraph_Sl_LO_Sc_GO_Sc_NO_Sg__doExport__SWIG_1(Tpetra::C #include "Tpetra_CrsMatrix.hpp" -SWIGINTERN Tpetra::CrsMatrix< SC,LO,GO,NO > *new_Tpetra_CrsMatrix_Sl_SC_Sc_LO_Sc_GO_Sc_NO_Sg___SWIG_10(Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &rowMap,std::pair< std::size_t const *,std::size_t > NumEntriesPerRowToAlloc,Tpetra::ProfileType pftype=Tpetra::DynamicProfile,Teuchos::RCP< Teuchos::ParameterList > const ¶ms=Teuchos::null){ - Teuchos::ArrayRCP NumEntriesPerRowToAllocArrayRCP(NumEntriesPerRowToAlloc.first, 0, NumEntriesPerRowToAlloc.second, false/*has_ownership*/); - return new Tpetra::CrsMatrix(rowMap, NumEntriesPerRowToAllocArrayRCP, pftype, params); +SWIGINTERN Tpetra::CrsMatrix< SC,LO,GO,NO > *new_Tpetra_CrsMatrix_Sl_SC_Sc_LO_Sc_GO_Sc_NO_Sg___SWIG_10(Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &rowMap,Teuchos::ArrayView< std::size_t const > NumEntriesPerRowToAlloc,Tpetra::ProfileType pftype=Tpetra::DynamicProfile,Teuchos::RCP< Teuchos::ParameterList > const ¶ms=Teuchos::null){ + return new Tpetra::CrsMatrix(rowMap, arcpFromArrayView(NumEntriesPerRowToAlloc), pftype, params); } -SWIGINTERN Tpetra::CrsMatrix< SC,LO,GO,NO > *new_Tpetra_CrsMatrix_Sl_SC_Sc_LO_Sc_GO_Sc_NO_Sg___SWIG_13(Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &rowMap,Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &colMap,std::pair< std::size_t const *,std::size_t > NumEntriesPerRowToAlloc,Tpetra::ProfileType pftype=Tpetra::DynamicProfile,Teuchos::RCP< Teuchos::ParameterList > const ¶ms=Teuchos::null){ - Teuchos::ArrayRCP NumEntriesPerRowToAllocArrayRCP(NumEntriesPerRowToAlloc.first, 0, NumEntriesPerRowToAlloc.second, false/*has_ownership*/); - return new Tpetra::CrsMatrix(rowMap, colMap, NumEntriesPerRowToAllocArrayRCP, pftype, params); +SWIGINTERN Tpetra::CrsMatrix< SC,LO,GO,NO > *new_Tpetra_CrsMatrix_Sl_SC_Sc_LO_Sc_GO_Sc_NO_Sg___SWIG_13(Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &rowMap,Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &colMap,Teuchos::ArrayView< std::size_t const > NumEntriesPerRowToAlloc,Tpetra::ProfileType pftype=Tpetra::DynamicProfile,Teuchos::RCP< Teuchos::ParameterList > const ¶ms=Teuchos::null){ + return new Tpetra::CrsMatrix(rowMap, colMap, arcpFromArrayView(NumEntriesPerRowToAlloc), pftype, params); } -SWIGINTERN Tpetra::CrsMatrix< SC,LO,GO,NO > *new_Tpetra_CrsMatrix_Sl_SC_Sc_LO_Sc_GO_Sc_NO_Sg___SWIG_16(Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &rowMap,Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &colMap,std::pair< std::size_t *,std::size_t > rowPointers,std::pair< LO *,std::size_t > columnIndices,std::pair< SC *,std::size_t > values,Teuchos::RCP< Teuchos::ParameterList > const ¶ms=Teuchos::null){ - Teuchos::ArrayRCP rowPointersArrayRCP(rowPointers.second); +SWIGINTERN Tpetra::CrsMatrix< SC,LO,GO,NO > *new_Tpetra_CrsMatrix_Sl_SC_Sc_LO_Sc_GO_Sc_NO_Sg___SWIG_16(Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &rowMap,Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &colMap,Teuchos::ArrayView< std::size_t > rowPointers,Teuchos::ArrayView< LO > columnIndices,Teuchos::ArrayView< SC > values,Teuchos::RCP< Teuchos::ParameterList > const ¶ms=Teuchos::null){ + Teuchos::ArrayRCP rowPointersArrayRCP(rowPointers.size()); for (int i = 0; i < rowPointersArrayRCP.size(); i++) - rowPointersArrayRCP[i] = rowPointers.first[i]-1; - Teuchos::ArrayRCP columnIndicesArrayRCP(columnIndices.second); + rowPointersArrayRCP[i] = rowPointers[i]-1; + Teuchos::ArrayRCP columnIndicesArrayRCP(columnIndices.size()); for (int i = 0; i < columnIndicesArrayRCP.size(); i++) - columnIndicesArrayRCP[i] = columnIndices.first[i]-1; - Teuchos::ArrayRCP valuesArrayRCP(values.first, 0, values.second, false/*has_ownership*/); - return new Tpetra::CrsMatrix(rowMap, colMap, rowPointersArrayRCP, columnIndicesArrayRCP, valuesArrayRCP, params); + columnIndicesArrayRCP[i] = columnIndices[i]-1; + return new Tpetra::CrsMatrix(rowMap, colMap, rowPointersArrayRCP, columnIndicesArrayRCP, arcpFromArrayView(values), params); } -SWIGINTERN void Tpetra_CrsMatrix_Sl_SC_Sc_LO_Sc_GO_Sc_NO_Sg__insertGlobalValues(Tpetra::CrsMatrix< SC,LO,GO,NO > *self,GO const globalRow,std::pair< GO const *,std::size_t > cols,std::pair< SC const *,std::size_t > vals){ - Teuchos::ArrayView colsView = Teuchos::arrayView(cols.first, cols.second); - Teuchos::ArrayView valsView = Teuchos::arrayView(vals.first, vals.second); - self->insertGlobalValues(globalRow, colsView, valsView); - } -SWIGINTERN void Tpetra_CrsMatrix_Sl_SC_Sc_LO_Sc_GO_Sc_NO_Sg__insertLocalValues(Tpetra::CrsMatrix< SC,LO,GO,NO > *self,LO const localRow,std::pair< LO const *,std::size_t > cols,std::pair< SC const *,std::size_t > vals){ - Teuchos::Array colsArray(cols.second); +SWIGINTERN void Tpetra_CrsMatrix_Sl_SC_Sc_LO_Sc_GO_Sc_NO_Sg__insertLocalValues(Tpetra::CrsMatrix< SC,LO,GO,NO > *self,LO const localRow,Teuchos::ArrayView< LO const > cols,Teuchos::ArrayView< SC const > vals){ + Teuchos::Array colsArray(cols.size()); for (int i = 0; i < colsArray.size(); i++) - colsArray[i] = cols.first[i] - 1; - Teuchos::ArrayView valsView = Teuchos::arrayView(vals.first, vals.second); + colsArray[i] = cols[i] - 1; + Teuchos::ArrayView valsView = Teuchos::arrayView(vals.getRawPtr(), vals.size()); self->insertLocalValues(localRow, colsArray, valsView); } -SWIGINTERN LO Tpetra_CrsMatrix_Sl_SC_Sc_LO_Sc_GO_Sc_NO_Sg__replaceGlobalValues(Tpetra::CrsMatrix< SC,LO,GO,NO > const *self,GO const globalRow,std::pair< GO const *,std::size_t > cols,std::pair< SC const *,std::size_t > vals){ - Teuchos::ArrayView colsView = Teuchos::arrayView(cols.first, cols.second); - Teuchos::ArrayView valsView = Teuchos::arrayView(vals.first, vals.second); - return self->replaceGlobalValues(globalRow, colsView, valsView); - } -SWIGINTERN LO Tpetra_CrsMatrix_Sl_SC_Sc_LO_Sc_GO_Sc_NO_Sg__sumIntoGlobalValues(Tpetra::CrsMatrix< SC,LO,GO,NO > *self,GO const globalRow,std::pair< GO const *,std::size_t > cols,std::pair< SC const *,std::size_t > vals){ - Teuchos::ArrayView colsView = Teuchos::arrayView(cols.first, cols.second); - Teuchos::ArrayView valsView = Teuchos::arrayView(vals.first, vals.second); - return self->sumIntoGlobalValues(globalRow, colsView, valsView, false); // TODO: for now, we only run in serial, no atomics necessary +SWIGINTERN LO Tpetra_CrsMatrix_Sl_SC_Sc_LO_Sc_GO_Sc_NO_Sg__sumIntoGlobalValues(Tpetra::CrsMatrix< SC,LO,GO,NO > *self,GO const globalRow,Teuchos::ArrayView< GO const > cols,Teuchos::ArrayView< SC const > vals){ + return self->sumIntoGlobalValues(globalRow, cols, vals, false); // TODO: for now, we only run in serial, no atomics necessary } -SWIGINTERN void Tpetra_CrsMatrix_Sl_SC_Sc_LO_Sc_GO_Sc_NO_Sg__setAllValues(Tpetra::CrsMatrix< SC,LO,GO,NO > *self,std::pair< std::size_t *,std::size_t > ptr,std::pair< LO *,std::size_t > ind,std::pair< SC *,std::size_t > val){ - Teuchos::ArrayRCP ptrArrayRCP(ptr.second); +SWIGINTERN void Tpetra_CrsMatrix_Sl_SC_Sc_LO_Sc_GO_Sc_NO_Sg__setAllValues(Tpetra::CrsMatrix< SC,LO,GO,NO > *self,Teuchos::ArrayView< std::size_t > ptr,Teuchos::ArrayView< LO > ind,Teuchos::ArrayView< SC > val){ + Teuchos::ArrayRCP ptrArrayRCP(ptr.size()); for (int i = 0; i < ptrArrayRCP.size(); i++) - ptrArrayRCP[i] = ptr.first[i]-1; - Teuchos::ArrayRCP indArrayRCP(ind.second); + ptrArrayRCP[i] = ptr[i]-1; + Teuchos::ArrayRCP indArrayRCP(ind.size()); for (int i = 0; i < indArrayRCP.size(); i++) - indArrayRCP[i] = ind.first[i]-1; - Teuchos::ArrayRCP valArrayRCP(val.first, 0, val.second, false/*has_ownership*/); - self->setAllValues(ptrArrayRCP, indArrayRCP, valArrayRCP); + indArrayRCP[i] = ind[i]-1; + Teuchos::ArrayRCP valArrayRCP(val.getRawPtr(), 0, val.size(), false/*has_ownership*/); + self->setAllValues(arcpFromArrayView(ptr), arcpFromArrayView(ind), arcpFromArrayView(val)); } -SWIGINTERN void Tpetra_CrsMatrix_Sl_SC_Sc_LO_Sc_GO_Sc_NO_Sg__getAllValues(Tpetra::CrsMatrix< SC,LO,GO,NO > const *self,std::pair< std::size_t *,std::size_t > rowPointers,std::pair< LO *,std::size_t > columnIndices,std::pair< SC *,std::size_t > values){ +SWIGINTERN void Tpetra_CrsMatrix_Sl_SC_Sc_LO_Sc_GO_Sc_NO_Sg__getAllValues(Tpetra::CrsMatrix< SC,LO,GO,NO > const *self,Teuchos::ArrayView< std::size_t > rowPointers,Teuchos::ArrayView< LO > columnIndices,Teuchos::ArrayView< SC > values){ Teuchos::ArrayRCP rowPointersArrayRCP; Teuchos::ArrayRCP columnIndicesArrayRCP; Teuchos::ArrayRCP valuesArrayRCP; self->getAllValues(rowPointersArrayRCP, columnIndicesArrayRCP, valuesArrayRCP); - TEUCHOS_TEST_FOR_EXCEPTION(rowPointersArrayRCP.size() != rowPointers.second, std::runtime_error, "Wrong rowPointers size"); - TEUCHOS_TEST_FOR_EXCEPTION(columnIndicesArrayRCP.size() != columnIndices.second, std::runtime_error, "Wrong columnIndices size"); - TEUCHOS_TEST_FOR_EXCEPTION(valuesArrayRCP.size() != values.second, std::runtime_error, "Wrong values size"); - auto n = rowPointers.second; + TEUCHOS_TEST_FOR_EXCEPTION(rowPointersArrayRCP.size() != rowPointers.size(), std::runtime_error, "Wrong rowPointers size"); + TEUCHOS_TEST_FOR_EXCEPTION(columnIndicesArrayRCP.size() != columnIndices.size(), std::runtime_error, "Wrong columnIndices size"); + TEUCHOS_TEST_FOR_EXCEPTION(valuesArrayRCP.size() != values.size(), std::runtime_error, "Wrong values size"); + auto n = rowPointers.size(); for (int i = 0; i < n; i++) - rowPointers.first[i] = rowPointersArrayRCP[i]+1; - auto nnz = columnIndices.second; + rowPointers[i] = rowPointersArrayRCP[i]+1; + auto nnz = columnIndices.size(); for (int i = 0; i < nnz; i++) { - columnIndices.first[i] = columnIndicesArrayRCP[i]+1; - values .first[i] = valuesArrayRCP[i]; + columnIndices[i] = columnIndicesArrayRCP[i]+1; + values [i] = valuesArrayRCP[i]; } } -SWIGINTERN void Tpetra_CrsMatrix_Sl_SC_Sc_LO_Sc_GO_Sc_NO_Sg__getGlobalRowCopy(Tpetra::CrsMatrix< SC,LO,GO,NO > const *self,GO GlobalRow,std::pair< GO *,std::size_t > Indices,std::pair< SC *,std::size_t > Values,size_t &NumIndices){ - Teuchos::ArrayView IndicesView = Teuchos::arrayView(Indices.first, Indices.second); - Teuchos::ArrayView ValuesView = Teuchos::arrayView(Values.first, Values.second); +SWIGINTERN void Tpetra_CrsMatrix_Sl_SC_Sc_LO_Sc_GO_Sc_NO_Sg__getLocalRowCopy(Tpetra::CrsMatrix< SC,LO,GO,NO > const *self,LO localRow,Teuchos::ArrayView< LO > colInds,Teuchos::ArrayView< SC > vals,size_t &NumIndices){ + self->getLocalRowCopy(localRow, colInds, vals, NumIndices); - self->getGlobalRowCopy(GlobalRow, IndicesView, ValuesView, NumIndices); - } -SWIGINTERN void Tpetra_CrsMatrix_Sl_SC_Sc_LO_Sc_GO_Sc_NO_Sg__getLocalRowCopy(Tpetra::CrsMatrix< SC,LO,GO,NO > const *self,LO localRow,std::pair< LO *,std::size_t > colInds,std::pair< SC *,std::size_t > vals,size_t &NumIndices){ - Teuchos::ArrayView colIndsView = Teuchos::arrayView(colInds.first, colInds.second); - Teuchos::ArrayView valsView = Teuchos::arrayView(vals.first, vals.second); - - self->getLocalRowCopy(localRow, colIndsView, valsView, NumIndices); - - for (int i = 0; i < colIndsView.size(); i++) - colIndsView[i]++; - } -SWIGINTERN void Tpetra_CrsMatrix_Sl_SC_Sc_LO_Sc_GO_Sc_NO_Sg__getGlobalRowView(Tpetra::CrsMatrix< SC,LO,GO,NO > const *self,GO GlobalRow,std::pair< GO const *,std::size_t > Indices,std::pair< SC const *,std::size_t > values){ - Teuchos::ArrayView IndicesView = Teuchos::arrayView(Indices.first, Indices.second); - Teuchos::ArrayView valuesView = Teuchos::arrayView(values.first, values.second); - - self->getGlobalRowView(GlobalRow, IndicesView, valuesView); - } -SWIGINTERN void Tpetra_CrsMatrix_Sl_SC_Sc_LO_Sc_GO_Sc_NO_Sg__getLocalDiagOffsets(Tpetra::CrsMatrix< SC,LO,GO,NO > const *self,std::pair< std::size_t *,std::size_t > offsets){ - TEUCHOS_TEST_FOR_EXCEPTION(self->getNodeNumRows() != offsets.second, std::runtime_error, "Wrong offsets size"); - Teuchos::ArrayRCP offsetsArrayRCP(offsets.first, 0, offsets.second, false/*has_ownership*/); - self->getLocalDiagOffsets(offsetsArrayRCP); + for (int i = 0; i < colInds.size(); i++) + colInds[i]++; } SWIGINTERN void Tpetra_CrsMatrix_Sl_SC_Sc_LO_Sc_GO_Sc_NO_Sg__doImport__SWIG_0(Tpetra::CrsMatrix< SC,LO,GO,NO > *self,Tpetra::CrsMatrix< SC,LO,GO,NO > const &source,Tpetra::Import< LO,GO,NO > const &importer,Tpetra::CombineMode CM){ self->doImport(source, importer, CM); @@ -4293,6 +4226,153 @@ SWIGEXPORT void _wrap_TpetraMultiVector_reduce(SwigClassWrapper const *farg1) { } +SWIGEXPORT SwigClassWrapper _wrap_TpetraMultiVector_subCopy(SwigClassWrapper const *farg1, SwigArrayWrapper *farg2) { + SwigClassWrapper fresult ; + Tpetra::MultiVector< SC,LO,GO,NO > *arg1 = (Tpetra::MultiVector< SC,LO,GO,NO > *) 0 ; + Teuchos::ArrayView< std::size_t const > *arg2 = 0 ; + Teuchos::RCP< Tpetra::MultiVector< SC,LO,GO,NO > const > *smartarg1 ; + Teuchos::ArrayView< std::size_t const >::value_type *tmpbegin2 ; + Teuchos::Array< std::remove_const< Teuchos::ArrayView< std::size_t const >::value_type >::type > tmparr2 ; + Teuchos::ArrayView< std::size_t const > tmpview2 ; + Teuchos::RCP< Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > > result; + + smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::MultiVector* >(smartarg1->get()) : NULL; + tmpbegin2 = static_cast::value_type*>(farg2->data); + tmparr2.resize(farg2->size); + for (int i = 0; i < tmparr2.size(); i++) + tmparr2[i] = tmpbegin2[i] - 1; + tmpview2 = tmparr2(); + + // Make the input argument point to our temporary vector + arg2 = &tmpview2; + { + // Make sure no unhandled exceptions exist before performing a new action + SWIG_check_unhandled_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::subCopy(Teuchos::ArrayView< std::size_t const > const &) const");; + try + { + // Attempt the wrapped function call + result = ((Tpetra::MultiVector< SC,LO,GO,NO > const *)arg1)->subCopy((Teuchos::ArrayView< std::size_t const > const &)*arg2); + } + catch (const std::range_error& e) + { + // Store a C++ exception + SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::subCopy(Teuchos::ArrayView< std::size_t const > const &) const", SWIG_IndexError, e.what(), return SwigClassWrapper_uninitialized()); + } + catch (const std::exception& e) + { + // Store a C++ exception + SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::subCopy(Teuchos::ArrayView< std::size_t const > const &) const", SWIG_RuntimeError, e.what(), return SwigClassWrapper_uninitialized()); + } + catch (...) + { + SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::subCopy(Teuchos::ArrayView< std::size_t const > const &) const", SWIG_UnknownError, "An unknown exception occurred", return SwigClassWrapper_uninitialized()); + } + } + fresult.cptr = (new Teuchos::RCP< Tpetra::MultiVector >(static_cast< const Teuchos::RCP< Tpetra::MultiVector >& >(result))); + fresult.mem = SWIG_MOVE; + return fresult; +} + + +SWIGEXPORT SwigClassWrapper _wrap_TpetraMultiVector_subView(SwigClassWrapper const *farg1, SwigArrayWrapper *farg2) { + SwigClassWrapper fresult ; + Tpetra::MultiVector< SC,LO,GO,NO > *arg1 = (Tpetra::MultiVector< SC,LO,GO,NO > *) 0 ; + Teuchos::ArrayView< std::size_t const > *arg2 = 0 ; + Teuchos::RCP< Tpetra::MultiVector< SC,LO,GO,NO > const > *smartarg1 ; + Teuchos::ArrayView< std::size_t const >::value_type *tmpbegin2 ; + Teuchos::Array< std::remove_const< Teuchos::ArrayView< std::size_t const >::value_type >::type > tmparr2 ; + Teuchos::ArrayView< std::size_t const > tmpview2 ; + Teuchos::RCP< Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const > result; + + smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::MultiVector* >(smartarg1->get()) : NULL; + tmpbegin2 = static_cast::value_type*>(farg2->data); + tmparr2.resize(farg2->size); + for (int i = 0; i < tmparr2.size(); i++) + tmparr2[i] = tmpbegin2[i] - 1; + tmpview2 = tmparr2(); + + // Make the input argument point to our temporary vector + arg2 = &tmpview2; + { + // Make sure no unhandled exceptions exist before performing a new action + SWIG_check_unhandled_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::subView(Teuchos::ArrayView< std::size_t const > const &) const");; + try + { + // Attempt the wrapped function call + result = ((Tpetra::MultiVector< SC,LO,GO,NO > const *)arg1)->subView((Teuchos::ArrayView< std::size_t const > const &)*arg2); + } + catch (const std::range_error& e) + { + // Store a C++ exception + SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::subView(Teuchos::ArrayView< std::size_t const > const &) const", SWIG_IndexError, e.what(), return SwigClassWrapper_uninitialized()); + } + catch (const std::exception& e) + { + // Store a C++ exception + SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::subView(Teuchos::ArrayView< std::size_t const > const &) const", SWIG_RuntimeError, e.what(), return SwigClassWrapper_uninitialized()); + } + catch (...) + { + SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::subView(Teuchos::ArrayView< std::size_t const > const &) const", SWIG_UnknownError, "An unknown exception occurred", return SwigClassWrapper_uninitialized()); + } + } + fresult.cptr = (new Teuchos::RCP >(static_cast< const Teuchos::RCP >& >(result))); + fresult.mem = SWIG_MOVE; + return fresult; +} + + +SWIGEXPORT SwigClassWrapper _wrap_TpetraMultiVector_subViewNonConst(SwigClassWrapper const *farg1, SwigArrayWrapper *farg2) { + SwigClassWrapper fresult ; + Tpetra::MultiVector< SC,LO,GO,NO > *arg1 = (Tpetra::MultiVector< SC,LO,GO,NO > *) 0 ; + Teuchos::ArrayView< std::size_t const > *arg2 = 0 ; + Teuchos::RCP< Tpetra::MultiVector< SC,LO,GO,NO > > *smartarg1 ; + Teuchos::ArrayView< std::size_t const >::value_type *tmpbegin2 ; + Teuchos::Array< std::remove_const< Teuchos::ArrayView< std::size_t const >::value_type >::type > tmparr2 ; + Teuchos::ArrayView< std::size_t const > tmpview2 ; + Teuchos::RCP< Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > > result; + + smartarg1 = static_cast< Teuchos::RCP< Tpetra::MultiVector >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::MultiVector* >(smartarg1->get()) : NULL; + tmpbegin2 = static_cast::value_type*>(farg2->data); + tmparr2.resize(farg2->size); + for (int i = 0; i < tmparr2.size(); i++) + tmparr2[i] = tmpbegin2[i] - 1; + tmpview2 = tmparr2(); + + // Make the input argument point to our temporary vector + arg2 = &tmpview2; + { + // Make sure no unhandled exceptions exist before performing a new action + SWIG_check_unhandled_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::subViewNonConst(Teuchos::ArrayView< std::size_t const > const &)");; + try + { + // Attempt the wrapped function call + result = (arg1)->subViewNonConst((Teuchos::ArrayView< std::size_t const > const &)*arg2); + } + catch (const std::range_error& e) + { + // Store a C++ exception + SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::subViewNonConst(Teuchos::ArrayView< std::size_t const > const &)", SWIG_IndexError, e.what(), return SwigClassWrapper_uninitialized()); + } + catch (const std::exception& e) + { + // Store a C++ exception + SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::subViewNonConst(Teuchos::ArrayView< std::size_t const > const &)", SWIG_RuntimeError, e.what(), return SwigClassWrapper_uninitialized()); + } + catch (...) + { + SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::subViewNonConst(Teuchos::ArrayView< std::size_t const > const &)", SWIG_UnknownError, "An unknown exception occurred", return SwigClassWrapper_uninitialized()); + } + } + fresult.cptr = (new Teuchos::RCP< Tpetra::MultiVector >(static_cast< const Teuchos::RCP< Tpetra::MultiVector >& >(result))); + fresult.mem = SWIG_MOVE; + return fresult; +} + + SWIGEXPORT SwigClassWrapper _wrap_TpetraMultiVector_offsetView(SwigClassWrapper const *farg1, SwigClassWrapper const *farg2, size_t const *farg3) { SwigClassWrapper fresult ; Tpetra::MultiVector< SC,LO,GO,NO > *arg1 = (Tpetra::MultiVector< SC,LO,GO,NO > *) 0 ; @@ -5843,126 +5923,6 @@ SWIGEXPORT int _wrap_TpetraMultiVector_isSameSize(SwigClassWrapper const *farg1, } -SWIGEXPORT SwigClassWrapper _wrap_TpetraMultiVector_subCopy(SwigClassWrapper const *farg1, SwigArrayWrapper *farg2) { - SwigClassWrapper fresult ; - Tpetra::MultiVector< SC,LO,GO,NO > *arg1 = (Tpetra::MultiVector< SC,LO,GO,NO > *) 0 ; - std::pair< std::size_t const *,std::size_t > arg2 ; - Teuchos::RCP< Tpetra::MultiVector< SC,LO,GO,NO > const > *smartarg1 ; - Teuchos::RCP< Tpetra::MultiVector< SC,LO,GO,NO > > result; - - smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); - arg1 = smartarg1 ? const_cast< Tpetra::MultiVector* >(smartarg1->get()) : NULL; - (&arg2)->first = static_cast(farg2->data); - (&arg2)->second = farg2->size; - { - // Make sure no unhandled exceptions exist before performing a new action - SWIG_check_unhandled_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::subCopy(std::pair< std::size_t const *,std::size_t >) const");; - try - { - // Attempt the wrapped function call - result = Tpetra_MultiVector_Sl_SC_Sc_LO_Sc_GO_Sc_NO_Sg__subCopy((Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const *)arg1,arg2); - } - catch (const std::range_error& e) - { - // Store a C++ exception - SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::subCopy(std::pair< std::size_t const *,std::size_t >) const", SWIG_IndexError, e.what(), return SwigClassWrapper_uninitialized()); - } - catch (const std::exception& e) - { - // Store a C++ exception - SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::subCopy(std::pair< std::size_t const *,std::size_t >) const", SWIG_RuntimeError, e.what(), return SwigClassWrapper_uninitialized()); - } - catch (...) - { - SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::subCopy(std::pair< std::size_t const *,std::size_t >) const", SWIG_UnknownError, "An unknown exception occurred", return SwigClassWrapper_uninitialized()); - } - } - fresult.cptr = (new Teuchos::RCP< Tpetra::MultiVector >(static_cast< const Teuchos::RCP< Tpetra::MultiVector >& >(result))); - fresult.mem = SWIG_MOVE; - return fresult; -} - - -SWIGEXPORT SwigClassWrapper _wrap_TpetraMultiVector_subView(SwigClassWrapper const *farg1, SwigArrayWrapper *farg2) { - SwigClassWrapper fresult ; - Tpetra::MultiVector< SC,LO,GO,NO > *arg1 = (Tpetra::MultiVector< SC,LO,GO,NO > *) 0 ; - std::pair< std::size_t const *,std::size_t > arg2 ; - Teuchos::RCP< Tpetra::MultiVector< SC,LO,GO,NO > const > *smartarg1 ; - Teuchos::RCP< Tpetra::MultiVector< SC,LO,GO,NO > const > result; - - smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); - arg1 = smartarg1 ? const_cast< Tpetra::MultiVector* >(smartarg1->get()) : NULL; - (&arg2)->first = static_cast(farg2->data); - (&arg2)->second = farg2->size; - { - // Make sure no unhandled exceptions exist before performing a new action - SWIG_check_unhandled_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::subView(std::pair< std::size_t const *,std::size_t >) const");; - try - { - // Attempt the wrapped function call - result = Tpetra_MultiVector_Sl_SC_Sc_LO_Sc_GO_Sc_NO_Sg__subView((Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const *)arg1,arg2); - } - catch (const std::range_error& e) - { - // Store a C++ exception - SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::subView(std::pair< std::size_t const *,std::size_t >) const", SWIG_IndexError, e.what(), return SwigClassWrapper_uninitialized()); - } - catch (const std::exception& e) - { - // Store a C++ exception - SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::subView(std::pair< std::size_t const *,std::size_t >) const", SWIG_RuntimeError, e.what(), return SwigClassWrapper_uninitialized()); - } - catch (...) - { - SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::subView(std::pair< std::size_t const *,std::size_t >) const", SWIG_UnknownError, "An unknown exception occurred", return SwigClassWrapper_uninitialized()); - } - } - fresult.cptr = (new Teuchos::RCP >(static_cast< const Teuchos::RCP >& >(result))); - fresult.mem = SWIG_MOVE; - return fresult; -} - - -SWIGEXPORT SwigClassWrapper _wrap_TpetraMultiVector_subViewNonConst(SwigClassWrapper const *farg1, SwigArrayWrapper *farg2) { - SwigClassWrapper fresult ; - Tpetra::MultiVector< SC,LO,GO,NO > *arg1 = (Tpetra::MultiVector< SC,LO,GO,NO > *) 0 ; - std::pair< std::size_t const *,std::size_t > arg2 ; - Teuchos::RCP< Tpetra::MultiVector< SC,LO,GO,NO > > *smartarg1 ; - Teuchos::RCP< Tpetra::MultiVector< SC,LO,GO,NO > > result; - - smartarg1 = static_cast< Teuchos::RCP< Tpetra::MultiVector >* >(farg1->cptr); - arg1 = smartarg1 ? const_cast< Tpetra::MultiVector* >(smartarg1->get()) : NULL; - (&arg2)->first = static_cast(farg2->data); - (&arg2)->second = farg2->size; - { - // Make sure no unhandled exceptions exist before performing a new action - SWIG_check_unhandled_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::subViewNonConst(std::pair< std::size_t const *,std::size_t >)");; - try - { - // Attempt the wrapped function call - result = Tpetra_MultiVector_Sl_SC_Sc_LO_Sc_GO_Sc_NO_Sg__subViewNonConst(arg1,arg2); - } - catch (const std::range_error& e) - { - // Store a C++ exception - SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::subViewNonConst(std::pair< std::size_t const *,std::size_t >)", SWIG_IndexError, e.what(), return SwigClassWrapper_uninitialized()); - } - catch (const std::exception& e) - { - // Store a C++ exception - SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::subViewNonConst(std::pair< std::size_t const *,std::size_t >)", SWIG_RuntimeError, e.what(), return SwigClassWrapper_uninitialized()); - } - catch (...) - { - SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::subViewNonConst(std::pair< std::size_t const *,std::size_t >)", SWIG_UnknownError, "An unknown exception occurred", return SwigClassWrapper_uninitialized()); - } - } - fresult.cptr = (new Teuchos::RCP< Tpetra::MultiVector >(static_cast< const Teuchos::RCP< Tpetra::MultiVector >& >(result))); - fresult.mem = SWIG_MOVE; - return fresult; -} - - SWIGEXPORT void _wrap_TpetraMultiVector_doImport__SWIG_0(SwigClassWrapper const *farg1, SwigClassWrapper const *farg2, SwigClassWrapper const *farg3, int const *farg4) { Tpetra::MultiVector< SC,LO,GO,NO > *arg1 = (Tpetra::MultiVector< SC,LO,GO,NO > *) 0 ; Tpetra::MultiVector< SC,LO,GO,NO > *arg2 = 0 ; @@ -8736,6 +8696,49 @@ SWIGEXPORT int _wrap_TpetraCrsGraph_getProfileType(SwigClassWrapper const *farg1 } +SWIGEXPORT void _wrap_TpetraCrsGraph_getGlobalRowCopy(SwigClassWrapper const *farg1, long long const *farg2, SwigArrayWrapper *farg3, size_t *farg4) { + Tpetra::CrsGraph< LO,GO,NO > *arg1 = (Tpetra::CrsGraph< LO,GO,NO > *) 0 ; + long long arg2 ; + Teuchos::ArrayView< long long > *arg3 = 0 ; + size_t *arg4 = 0 ; + Teuchos::RCP< Tpetra::CrsGraph< LO,GO,NO > const > *smartarg1 ; + long long *tempbegin3 ; + Teuchos::ArrayView< long long > temparr3 ; + + smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::CrsGraph* >(smartarg1->get()) : NULL; + arg2 = static_cast< long long >(*farg2); + tempbegin3 = static_cast(farg3->data); + temparr3 = Teuchos::ArrayView(tempbegin3, farg3->size); + arg3 = &temparr3; + arg4 = reinterpret_cast< size_t * >(farg4); + { + // Make sure no unhandled exceptions exist before performing a new action + SWIG_check_unhandled_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::getGlobalRowCopy(long long,Teuchos::ArrayView< long long > const &,size_t &) const");; + try + { + // Attempt the wrapped function call + ((Tpetra::CrsGraph< LO,GO,NO > const *)arg1)->getGlobalRowCopy(arg2,(Teuchos::ArrayView< long long > const &)*arg3,*arg4); + } + catch (const std::range_error& e) + { + // Store a C++ exception + SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::getGlobalRowCopy(long long,Teuchos::ArrayView< long long > const &,size_t &) const", SWIG_IndexError, e.what(), return ); + } + catch (const std::exception& e) + { + // Store a C++ exception + SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::getGlobalRowCopy(long long,Teuchos::ArrayView< long long > const &,size_t &) const", SWIG_RuntimeError, e.what(), return ); + } + catch (...) + { + SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::getGlobalRowCopy(long long,Teuchos::ArrayView< long long > const &,size_t &) const", SWIG_UnknownError, "An unknown exception occurred", return ); + } + } + +} + + SWIGEXPORT int _wrap_TpetraCrsGraph_supportsRowViews(SwigClassWrapper const *farg1) { int fresult ; Tpetra::CrsGraph< LO,GO,NO > *arg1 = (Tpetra::CrsGraph< LO,GO,NO > *) 0 ; @@ -9504,21 +9507,22 @@ SWIGEXPORT void _wrap_TpetraCrsGraph_computeGlobalConstants(SwigClassWrapper con SWIGEXPORT SwigClassWrapper _wrap_new_TpetraCrsGraph__SWIG_6(SwigClassWrapper const *farg1, SwigArrayWrapper *farg2, int const *farg3, SwigClassWrapper const *farg4) { SwigClassWrapper fresult ; Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > *arg1 = 0 ; - std::pair< std::size_t const *,std::size_t > arg2 ; + Teuchos::ArrayView< std::size_t const > arg2 ; Tpetra::ProfileType arg3 ; Teuchos::RCP< Teuchos::ParameterList > *arg4 = 0 ; Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > tempnull1 ; + unsigned long const *tempbegin2 ; Teuchos::RCP< Teuchos::ParameterList > tempnull4 ; Tpetra::CrsGraph< LO,GO,NO > *result = 0 ; arg1 = farg1->cptr ? static_cast< Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg1->cptr) : &tempnull1; - (&arg2)->first = static_cast(farg2->data); - (&arg2)->second = farg2->size; + tempbegin2 = static_cast(farg2->data); + arg2 = Teuchos::ArrayView(tempbegin2, farg2->size); arg3 = static_cast< Tpetra::ProfileType >(*farg3); arg4 = farg4->cptr ? static_cast< Teuchos::RCP< Teuchos::ParameterList > * >(farg4->cptr) : &tempnull4; { // Make sure no unhandled exceptions exist before performing a new action - SWIG_check_unhandled_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::CrsGraph(Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,std::pair< std::size_t const *,std::size_t >,Tpetra::ProfileType const,Teuchos::RCP< Teuchos::ParameterList > const &)");; + SWIG_check_unhandled_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::CrsGraph(Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::ArrayView< std::size_t const >,Tpetra::ProfileType const,Teuchos::RCP< Teuchos::ParameterList > const &)");; try { // Attempt the wrapped function call @@ -9527,16 +9531,16 @@ SWIGEXPORT SwigClassWrapper _wrap_new_TpetraCrsGraph__SWIG_6(SwigClassWrapper co catch (const std::range_error& e) { // Store a C++ exception - SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::CrsGraph(Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,std::pair< std::size_t const *,std::size_t >,Tpetra::ProfileType const,Teuchos::RCP< Teuchos::ParameterList > const &)", SWIG_IndexError, e.what(), return SwigClassWrapper_uninitialized()); + SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::CrsGraph(Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::ArrayView< std::size_t const >,Tpetra::ProfileType const,Teuchos::RCP< Teuchos::ParameterList > const &)", SWIG_IndexError, e.what(), return SwigClassWrapper_uninitialized()); } catch (const std::exception& e) { // Store a C++ exception - SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::CrsGraph(Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,std::pair< std::size_t const *,std::size_t >,Tpetra::ProfileType const,Teuchos::RCP< Teuchos::ParameterList > const &)", SWIG_RuntimeError, e.what(), return SwigClassWrapper_uninitialized()); + SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::CrsGraph(Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::ArrayView< std::size_t const >,Tpetra::ProfileType const,Teuchos::RCP< Teuchos::ParameterList > const &)", SWIG_RuntimeError, e.what(), return SwigClassWrapper_uninitialized()); } catch (...) { - SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::CrsGraph(Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,std::pair< std::size_t const *,std::size_t >,Tpetra::ProfileType const,Teuchos::RCP< Teuchos::ParameterList > const &)", SWIG_UnknownError, "An unknown exception occurred", return SwigClassWrapper_uninitialized()); + SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::CrsGraph(Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::ArrayView< std::size_t const >,Tpetra::ProfileType const,Teuchos::RCP< Teuchos::ParameterList > const &)", SWIG_UnknownError, "An unknown exception occurred", return SwigClassWrapper_uninitialized()); } } fresult.cptr = result ? new Teuchos::RCP< Tpetra::CrsGraph >(result SWIG_NO_NULL_DELETER_1) : NULL; @@ -9548,18 +9552,19 @@ SWIGEXPORT SwigClassWrapper _wrap_new_TpetraCrsGraph__SWIG_6(SwigClassWrapper co SWIGEXPORT SwigClassWrapper _wrap_new_TpetraCrsGraph__SWIG_7(SwigClassWrapper const *farg1, SwigArrayWrapper *farg2, int const *farg3) { SwigClassWrapper fresult ; Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > *arg1 = 0 ; - std::pair< std::size_t const *,std::size_t > arg2 ; + Teuchos::ArrayView< std::size_t const > arg2 ; Tpetra::ProfileType arg3 ; Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > tempnull1 ; + unsigned long const *tempbegin2 ; Tpetra::CrsGraph< LO,GO,NO > *result = 0 ; arg1 = farg1->cptr ? static_cast< Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg1->cptr) : &tempnull1; - (&arg2)->first = static_cast(farg2->data); - (&arg2)->second = farg2->size; + tempbegin2 = static_cast(farg2->data); + arg2 = Teuchos::ArrayView(tempbegin2, farg2->size); arg3 = static_cast< Tpetra::ProfileType >(*farg3); { // Make sure no unhandled exceptions exist before performing a new action - SWIG_check_unhandled_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::CrsGraph(Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,std::pair< std::size_t const *,std::size_t >,Tpetra::ProfileType const)");; + SWIG_check_unhandled_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::CrsGraph(Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::ArrayView< std::size_t const >,Tpetra::ProfileType const)");; try { // Attempt the wrapped function call @@ -9568,16 +9573,16 @@ SWIGEXPORT SwigClassWrapper _wrap_new_TpetraCrsGraph__SWIG_7(SwigClassWrapper co catch (const std::range_error& e) { // Store a C++ exception - SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::CrsGraph(Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,std::pair< std::size_t const *,std::size_t >,Tpetra::ProfileType const)", SWIG_IndexError, e.what(), return SwigClassWrapper_uninitialized()); + SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::CrsGraph(Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::ArrayView< std::size_t const >,Tpetra::ProfileType const)", SWIG_IndexError, e.what(), return SwigClassWrapper_uninitialized()); } catch (const std::exception& e) { // Store a C++ exception - SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::CrsGraph(Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,std::pair< std::size_t const *,std::size_t >,Tpetra::ProfileType const)", SWIG_RuntimeError, e.what(), return SwigClassWrapper_uninitialized()); + SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::CrsGraph(Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::ArrayView< std::size_t const >,Tpetra::ProfileType const)", SWIG_RuntimeError, e.what(), return SwigClassWrapper_uninitialized()); } catch (...) { - SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::CrsGraph(Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,std::pair< std::size_t const *,std::size_t >,Tpetra::ProfileType const)", SWIG_UnknownError, "An unknown exception occurred", return SwigClassWrapper_uninitialized()); + SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::CrsGraph(Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::ArrayView< std::size_t const >,Tpetra::ProfileType const)", SWIG_UnknownError, "An unknown exception occurred", return SwigClassWrapper_uninitialized()); } } fresult.cptr = result ? new Teuchos::RCP< Tpetra::CrsGraph >(result SWIG_NO_NULL_DELETER_1) : NULL; @@ -9589,16 +9594,17 @@ SWIGEXPORT SwigClassWrapper _wrap_new_TpetraCrsGraph__SWIG_7(SwigClassWrapper co SWIGEXPORT SwigClassWrapper _wrap_new_TpetraCrsGraph__SWIG_8(SwigClassWrapper const *farg1, SwigArrayWrapper *farg2) { SwigClassWrapper fresult ; Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > *arg1 = 0 ; - std::pair< std::size_t const *,std::size_t > arg2 ; + Teuchos::ArrayView< std::size_t const > arg2 ; Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > tempnull1 ; + unsigned long const *tempbegin2 ; Tpetra::CrsGraph< LO,GO,NO > *result = 0 ; arg1 = farg1->cptr ? static_cast< Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg1->cptr) : &tempnull1; - (&arg2)->first = static_cast(farg2->data); - (&arg2)->second = farg2->size; + tempbegin2 = static_cast(farg2->data); + arg2 = Teuchos::ArrayView(tempbegin2, farg2->size); { // Make sure no unhandled exceptions exist before performing a new action - SWIG_check_unhandled_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::CrsGraph(Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,std::pair< std::size_t const *,std::size_t >)");; + SWIG_check_unhandled_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::CrsGraph(Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::ArrayView< std::size_t const >)");; try { // Attempt the wrapped function call @@ -9607,16 +9613,16 @@ SWIGEXPORT SwigClassWrapper _wrap_new_TpetraCrsGraph__SWIG_8(SwigClassWrapper co catch (const std::range_error& e) { // Store a C++ exception - SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::CrsGraph(Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,std::pair< std::size_t const *,std::size_t >)", SWIG_IndexError, e.what(), return SwigClassWrapper_uninitialized()); + SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::CrsGraph(Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::ArrayView< std::size_t const >)", SWIG_IndexError, e.what(), return SwigClassWrapper_uninitialized()); } catch (const std::exception& e) { // Store a C++ exception - SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::CrsGraph(Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,std::pair< std::size_t const *,std::size_t >)", SWIG_RuntimeError, e.what(), return SwigClassWrapper_uninitialized()); + SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::CrsGraph(Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::ArrayView< std::size_t const >)", SWIG_RuntimeError, e.what(), return SwigClassWrapper_uninitialized()); } catch (...) { - SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::CrsGraph(Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,std::pair< std::size_t const *,std::size_t >)", SWIG_UnknownError, "An unknown exception occurred", return SwigClassWrapper_uninitialized()); + SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::CrsGraph(Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::ArrayView< std::size_t const >)", SWIG_UnknownError, "An unknown exception occurred", return SwigClassWrapper_uninitialized()); } } fresult.cptr = result ? new Teuchos::RCP< Tpetra::CrsGraph >(result SWIG_NO_NULL_DELETER_1) : NULL; @@ -9629,23 +9635,24 @@ SWIGEXPORT SwigClassWrapper _wrap_new_TpetraCrsGraph__SWIG_9(SwigClassWrapper co SwigClassWrapper fresult ; Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > *arg1 = 0 ; Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > *arg2 = 0 ; - std::pair< std::size_t const *,std::size_t > arg3 ; + Teuchos::ArrayView< std::size_t const > arg3 ; Tpetra::ProfileType arg4 ; Teuchos::RCP< Teuchos::ParameterList > *arg5 = 0 ; Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > tempnull1 ; Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > tempnull2 ; + unsigned long const *tempbegin3 ; Teuchos::RCP< Teuchos::ParameterList > tempnull5 ; Tpetra::CrsGraph< LO,GO,NO > *result = 0 ; arg1 = farg1->cptr ? static_cast< Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg1->cptr) : &tempnull1; arg2 = farg2->cptr ? static_cast< Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg2->cptr) : &tempnull2; - (&arg3)->first = static_cast(farg3->data); - (&arg3)->second = farg3->size; + tempbegin3 = static_cast(farg3->data); + arg3 = Teuchos::ArrayView(tempbegin3, farg3->size); arg4 = static_cast< Tpetra::ProfileType >(*farg4); arg5 = farg5->cptr ? static_cast< Teuchos::RCP< Teuchos::ParameterList > * >(farg5->cptr) : &tempnull5; { // Make sure no unhandled exceptions exist before performing a new action - SWIG_check_unhandled_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::CrsGraph(Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,std::pair< std::size_t const *,std::size_t >,Tpetra::ProfileType const,Teuchos::RCP< Teuchos::ParameterList > const &)");; + SWIG_check_unhandled_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::CrsGraph(Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::ArrayView< std::size_t const >,Tpetra::ProfileType const,Teuchos::RCP< Teuchos::ParameterList > const &)");; try { // Attempt the wrapped function call @@ -9654,16 +9661,16 @@ SWIGEXPORT SwigClassWrapper _wrap_new_TpetraCrsGraph__SWIG_9(SwigClassWrapper co catch (const std::range_error& e) { // Store a C++ exception - SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::CrsGraph(Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,std::pair< std::size_t const *,std::size_t >,Tpetra::ProfileType const,Teuchos::RCP< Teuchos::ParameterList > const &)", SWIG_IndexError, e.what(), return SwigClassWrapper_uninitialized()); + SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::CrsGraph(Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::ArrayView< std::size_t const >,Tpetra::ProfileType const,Teuchos::RCP< Teuchos::ParameterList > const &)", SWIG_IndexError, e.what(), return SwigClassWrapper_uninitialized()); } catch (const std::exception& e) { // Store a C++ exception - SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::CrsGraph(Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,std::pair< std::size_t const *,std::size_t >,Tpetra::ProfileType const,Teuchos::RCP< Teuchos::ParameterList > const &)", SWIG_RuntimeError, e.what(), return SwigClassWrapper_uninitialized()); + SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::CrsGraph(Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::ArrayView< std::size_t const >,Tpetra::ProfileType const,Teuchos::RCP< Teuchos::ParameterList > const &)", SWIG_RuntimeError, e.what(), return SwigClassWrapper_uninitialized()); } catch (...) { - SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::CrsGraph(Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,std::pair< std::size_t const *,std::size_t >,Tpetra::ProfileType const,Teuchos::RCP< Teuchos::ParameterList > const &)", SWIG_UnknownError, "An unknown exception occurred", return SwigClassWrapper_uninitialized()); + SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::CrsGraph(Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::ArrayView< std::size_t const >,Tpetra::ProfileType const,Teuchos::RCP< Teuchos::ParameterList > const &)", SWIG_UnknownError, "An unknown exception occurred", return SwigClassWrapper_uninitialized()); } } fresult.cptr = result ? new Teuchos::RCP< Tpetra::CrsGraph >(result SWIG_NO_NULL_DELETER_1) : NULL; @@ -9676,20 +9683,21 @@ SWIGEXPORT SwigClassWrapper _wrap_new_TpetraCrsGraph__SWIG_10(SwigClassWrapper c SwigClassWrapper fresult ; Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > *arg1 = 0 ; Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > *arg2 = 0 ; - std::pair< std::size_t const *,std::size_t > arg3 ; + Teuchos::ArrayView< std::size_t const > arg3 ; Tpetra::ProfileType arg4 ; Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > tempnull1 ; Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > tempnull2 ; + unsigned long const *tempbegin3 ; Tpetra::CrsGraph< LO,GO,NO > *result = 0 ; arg1 = farg1->cptr ? static_cast< Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg1->cptr) : &tempnull1; arg2 = farg2->cptr ? static_cast< Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg2->cptr) : &tempnull2; - (&arg3)->first = static_cast(farg3->data); - (&arg3)->second = farg3->size; + tempbegin3 = static_cast(farg3->data); + arg3 = Teuchos::ArrayView(tempbegin3, farg3->size); arg4 = static_cast< Tpetra::ProfileType >(*farg4); { // Make sure no unhandled exceptions exist before performing a new action - SWIG_check_unhandled_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::CrsGraph(Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,std::pair< std::size_t const *,std::size_t >,Tpetra::ProfileType const)");; + SWIG_check_unhandled_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::CrsGraph(Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::ArrayView< std::size_t const >,Tpetra::ProfileType const)");; try { // Attempt the wrapped function call @@ -9698,16 +9706,16 @@ SWIGEXPORT SwigClassWrapper _wrap_new_TpetraCrsGraph__SWIG_10(SwigClassWrapper c catch (const std::range_error& e) { // Store a C++ exception - SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::CrsGraph(Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,std::pair< std::size_t const *,std::size_t >,Tpetra::ProfileType const)", SWIG_IndexError, e.what(), return SwigClassWrapper_uninitialized()); + SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::CrsGraph(Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::ArrayView< std::size_t const >,Tpetra::ProfileType const)", SWIG_IndexError, e.what(), return SwigClassWrapper_uninitialized()); } catch (const std::exception& e) { // Store a C++ exception - SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::CrsGraph(Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,std::pair< std::size_t const *,std::size_t >,Tpetra::ProfileType const)", SWIG_RuntimeError, e.what(), return SwigClassWrapper_uninitialized()); + SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::CrsGraph(Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::ArrayView< std::size_t const >,Tpetra::ProfileType const)", SWIG_RuntimeError, e.what(), return SwigClassWrapper_uninitialized()); } catch (...) { - SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::CrsGraph(Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,std::pair< std::size_t const *,std::size_t >,Tpetra::ProfileType const)", SWIG_UnknownError, "An unknown exception occurred", return SwigClassWrapper_uninitialized()); + SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::CrsGraph(Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::ArrayView< std::size_t const >,Tpetra::ProfileType const)", SWIG_UnknownError, "An unknown exception occurred", return SwigClassWrapper_uninitialized()); } } fresult.cptr = result ? new Teuchos::RCP< Tpetra::CrsGraph >(result SWIG_NO_NULL_DELETER_1) : NULL; @@ -9720,18 +9728,19 @@ SWIGEXPORT SwigClassWrapper _wrap_new_TpetraCrsGraph__SWIG_11(SwigClassWrapper c SwigClassWrapper fresult ; Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > *arg1 = 0 ; Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > *arg2 = 0 ; - std::pair< std::size_t const *,std::size_t > arg3 ; + Teuchos::ArrayView< std::size_t const > arg3 ; Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > tempnull1 ; Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > tempnull2 ; + unsigned long const *tempbegin3 ; Tpetra::CrsGraph< LO,GO,NO > *result = 0 ; arg1 = farg1->cptr ? static_cast< Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg1->cptr) : &tempnull1; arg2 = farg2->cptr ? static_cast< Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg2->cptr) : &tempnull2; - (&arg3)->first = static_cast(farg3->data); - (&arg3)->second = farg3->size; + tempbegin3 = static_cast(farg3->data); + arg3 = Teuchos::ArrayView(tempbegin3, farg3->size); { // Make sure no unhandled exceptions exist before performing a new action - SWIG_check_unhandled_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::CrsGraph(Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,std::pair< std::size_t const *,std::size_t >)");; + SWIG_check_unhandled_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::CrsGraph(Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::ArrayView< std::size_t const >)");; try { // Attempt the wrapped function call @@ -9740,16 +9749,16 @@ SWIGEXPORT SwigClassWrapper _wrap_new_TpetraCrsGraph__SWIG_11(SwigClassWrapper c catch (const std::range_error& e) { // Store a C++ exception - SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::CrsGraph(Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,std::pair< std::size_t const *,std::size_t >)", SWIG_IndexError, e.what(), return SwigClassWrapper_uninitialized()); + SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::CrsGraph(Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::ArrayView< std::size_t const >)", SWIG_IndexError, e.what(), return SwigClassWrapper_uninitialized()); } catch (const std::exception& e) { // Store a C++ exception - SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::CrsGraph(Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,std::pair< std::size_t const *,std::size_t >)", SWIG_RuntimeError, e.what(), return SwigClassWrapper_uninitialized()); + SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::CrsGraph(Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::ArrayView< std::size_t const >)", SWIG_RuntimeError, e.what(), return SwigClassWrapper_uninitialized()); } catch (...) { - SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::CrsGraph(Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,std::pair< std::size_t const *,std::size_t >)", SWIG_UnknownError, "An unknown exception occurred", return SwigClassWrapper_uninitialized()); + SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::CrsGraph(Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::ArrayView< std::size_t const >)", SWIG_UnknownError, "An unknown exception occurred", return SwigClassWrapper_uninitialized()); } } fresult.cptr = result ? new Teuchos::RCP< Tpetra::CrsGraph >(result SWIG_NO_NULL_DELETER_1) : NULL; @@ -9762,24 +9771,26 @@ SWIGEXPORT SwigClassWrapper _wrap_new_TpetraCrsGraph__SWIG_12(SwigClassWrapper c SwigClassWrapper fresult ; Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > *arg1 = 0 ; Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > *arg2 = 0 ; - std::pair< std::size_t *,std::size_t > arg3 ; - std::pair< LO *,std::size_t > arg4 ; + Teuchos::ArrayView< std::size_t > arg3 ; + Teuchos::ArrayView< LO > arg4 ; Teuchos::RCP< Teuchos::ParameterList > *arg5 = 0 ; Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > tempnull1 ; Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > tempnull2 ; + unsigned long *tempbegin3 ; + int *tempbegin4 ; Teuchos::RCP< Teuchos::ParameterList > tempnull5 ; Tpetra::CrsGraph< LO,GO,NO > *result = 0 ; arg1 = farg1->cptr ? static_cast< Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg1->cptr) : &tempnull1; arg2 = farg2->cptr ? static_cast< Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg2->cptr) : &tempnull2; - (&arg3)->first = static_cast(farg3->data); - (&arg3)->second = farg3->size; - (&arg4)->first = static_cast(farg4->data); - (&arg4)->second = farg4->size; + tempbegin3 = static_cast(farg3->data); + arg3 = Teuchos::ArrayView(tempbegin3, farg3->size); + tempbegin4 = static_cast(farg4->data); + arg4 = Teuchos::ArrayView(tempbegin4, farg4->size); arg5 = farg5->cptr ? static_cast< Teuchos::RCP< Teuchos::ParameterList > * >(farg5->cptr) : &tempnull5; { // Make sure no unhandled exceptions exist before performing a new action - SWIG_check_unhandled_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::CrsGraph(Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,std::pair< std::size_t *,std::size_t >,std::pair< LO *,std::size_t >,Teuchos::RCP< Teuchos::ParameterList > const &)");; + SWIG_check_unhandled_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::CrsGraph(Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::ArrayView< std::size_t >,Teuchos::ArrayView< LO >,Teuchos::RCP< Teuchos::ParameterList > const &)");; try { // Attempt the wrapped function call @@ -9788,16 +9799,16 @@ SWIGEXPORT SwigClassWrapper _wrap_new_TpetraCrsGraph__SWIG_12(SwigClassWrapper c catch (const std::range_error& e) { // Store a C++ exception - SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::CrsGraph(Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,std::pair< std::size_t *,std::size_t >,std::pair< LO *,std::size_t >,Teuchos::RCP< Teuchos::ParameterList > const &)", SWIG_IndexError, e.what(), return SwigClassWrapper_uninitialized()); + SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::CrsGraph(Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::ArrayView< std::size_t >,Teuchos::ArrayView< LO >,Teuchos::RCP< Teuchos::ParameterList > const &)", SWIG_IndexError, e.what(), return SwigClassWrapper_uninitialized()); } catch (const std::exception& e) { // Store a C++ exception - SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::CrsGraph(Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,std::pair< std::size_t *,std::size_t >,std::pair< LO *,std::size_t >,Teuchos::RCP< Teuchos::ParameterList > const &)", SWIG_RuntimeError, e.what(), return SwigClassWrapper_uninitialized()); + SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::CrsGraph(Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::ArrayView< std::size_t >,Teuchos::ArrayView< LO >,Teuchos::RCP< Teuchos::ParameterList > const &)", SWIG_RuntimeError, e.what(), return SwigClassWrapper_uninitialized()); } catch (...) { - SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::CrsGraph(Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,std::pair< std::size_t *,std::size_t >,std::pair< LO *,std::size_t >,Teuchos::RCP< Teuchos::ParameterList > const &)", SWIG_UnknownError, "An unknown exception occurred", return SwigClassWrapper_uninitialized()); + SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::CrsGraph(Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::ArrayView< std::size_t >,Teuchos::ArrayView< LO >,Teuchos::RCP< Teuchos::ParameterList > const &)", SWIG_UnknownError, "An unknown exception occurred", return SwigClassWrapper_uninitialized()); } } fresult.cptr = result ? new Teuchos::RCP< Tpetra::CrsGraph >(result SWIG_NO_NULL_DELETER_1) : NULL; @@ -9810,21 +9821,23 @@ SWIGEXPORT SwigClassWrapper _wrap_new_TpetraCrsGraph__SWIG_13(SwigClassWrapper c SwigClassWrapper fresult ; Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > *arg1 = 0 ; Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > *arg2 = 0 ; - std::pair< std::size_t *,std::size_t > arg3 ; - std::pair< LO *,std::size_t > arg4 ; + Teuchos::ArrayView< std::size_t > arg3 ; + Teuchos::ArrayView< LO > arg4 ; Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > tempnull1 ; Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > tempnull2 ; + unsigned long *tempbegin3 ; + int *tempbegin4 ; Tpetra::CrsGraph< LO,GO,NO > *result = 0 ; arg1 = farg1->cptr ? static_cast< Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg1->cptr) : &tempnull1; arg2 = farg2->cptr ? static_cast< Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg2->cptr) : &tempnull2; - (&arg3)->first = static_cast(farg3->data); - (&arg3)->second = farg3->size; - (&arg4)->first = static_cast(farg4->data); - (&arg4)->second = farg4->size; + tempbegin3 = static_cast(farg3->data); + arg3 = Teuchos::ArrayView(tempbegin3, farg3->size); + tempbegin4 = static_cast(farg4->data); + arg4 = Teuchos::ArrayView(tempbegin4, farg4->size); { // Make sure no unhandled exceptions exist before performing a new action - SWIG_check_unhandled_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::CrsGraph(Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,std::pair< std::size_t *,std::size_t >,std::pair< LO *,std::size_t >)");; + SWIG_check_unhandled_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::CrsGraph(Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::ArrayView< std::size_t >,Teuchos::ArrayView< LO >)");; try { // Attempt the wrapped function call @@ -9833,16 +9846,16 @@ SWIGEXPORT SwigClassWrapper _wrap_new_TpetraCrsGraph__SWIG_13(SwigClassWrapper c catch (const std::range_error& e) { // Store a C++ exception - SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::CrsGraph(Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,std::pair< std::size_t *,std::size_t >,std::pair< LO *,std::size_t >)", SWIG_IndexError, e.what(), return SwigClassWrapper_uninitialized()); + SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::CrsGraph(Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::ArrayView< std::size_t >,Teuchos::ArrayView< LO >)", SWIG_IndexError, e.what(), return SwigClassWrapper_uninitialized()); } catch (const std::exception& e) { // Store a C++ exception - SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::CrsGraph(Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,std::pair< std::size_t *,std::size_t >,std::pair< LO *,std::size_t >)", SWIG_RuntimeError, e.what(), return SwigClassWrapper_uninitialized()); + SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::CrsGraph(Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::ArrayView< std::size_t >,Teuchos::ArrayView< LO >)", SWIG_RuntimeError, e.what(), return SwigClassWrapper_uninitialized()); } catch (...) { - SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::CrsGraph(Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,std::pair< std::size_t *,std::size_t >,std::pair< LO *,std::size_t >)", SWIG_UnknownError, "An unknown exception occurred", return SwigClassWrapper_uninitialized()); + SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::CrsGraph(Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::ArrayView< std::size_t >,Teuchos::ArrayView< LO >)", SWIG_UnknownError, "An unknown exception occurred", return SwigClassWrapper_uninitialized()); } } fresult.cptr = result ? new Teuchos::RCP< Tpetra::CrsGraph >(result SWIG_NO_NULL_DELETER_1) : NULL; @@ -9854,17 +9867,18 @@ SWIGEXPORT SwigClassWrapper _wrap_new_TpetraCrsGraph__SWIG_13(SwigClassWrapper c SWIGEXPORT void _wrap_TpetraCrsGraph_insertGlobalIndices__SWIG_1(SwigClassWrapper const *farg1, long long const *farg2, SwigArrayWrapper *farg3) { Tpetra::CrsGraph< LO,GO,NO > *arg1 = (Tpetra::CrsGraph< LO,GO,NO > *) 0 ; GO arg2 ; - std::pair< GO const *,std::size_t > arg3 ; + Teuchos::ArrayView< GO const > arg3 ; Teuchos::RCP< Tpetra::CrsGraph< LO,GO,NO > > *smartarg1 ; + long long const *tempbegin3 ; smartarg1 = static_cast< Teuchos::RCP< Tpetra::CrsGraph >* >(farg1->cptr); arg1 = smartarg1 ? const_cast< Tpetra::CrsGraph* >(smartarg1->get()) : NULL; arg2 = static_cast< GO >(*farg2); - (&arg3)->first = static_cast(farg3->data); - (&arg3)->second = farg3->size; + tempbegin3 = static_cast(farg3->data); + arg3 = Teuchos::ArrayView(tempbegin3, farg3->size); { // Make sure no unhandled exceptions exist before performing a new action - SWIG_check_unhandled_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::insertGlobalIndices(GO const,std::pair< GO const *,std::size_t >)");; + SWIG_check_unhandled_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::insertGlobalIndices(GO const,Teuchos::ArrayView< GO const >)");; try { // Attempt the wrapped function call @@ -9873,16 +9887,16 @@ SWIGEXPORT void _wrap_TpetraCrsGraph_insertGlobalIndices__SWIG_1(SwigClassWrappe catch (const std::range_error& e) { // Store a C++ exception - SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::insertGlobalIndices(GO const,std::pair< GO const *,std::size_t >)", SWIG_IndexError, e.what(), return ); + SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::insertGlobalIndices(GO const,Teuchos::ArrayView< GO const >)", SWIG_IndexError, e.what(), return ); } catch (const std::exception& e) { // Store a C++ exception - SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::insertGlobalIndices(GO const,std::pair< GO const *,std::size_t >)", SWIG_RuntimeError, e.what(), return ); + SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::insertGlobalIndices(GO const,Teuchos::ArrayView< GO const >)", SWIG_RuntimeError, e.what(), return ); } catch (...) { - SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::insertGlobalIndices(GO const,std::pair< GO const *,std::size_t >)", SWIG_UnknownError, "An unknown exception occurred", return ); + SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::insertGlobalIndices(GO const,Teuchos::ArrayView< GO const >)", SWIG_UnknownError, "An unknown exception occurred", return ); } } @@ -9892,17 +9906,18 @@ SWIGEXPORT void _wrap_TpetraCrsGraph_insertGlobalIndices__SWIG_1(SwigClassWrappe SWIGEXPORT void _wrap_TpetraCrsGraph_insertLocalIndices(SwigClassWrapper const *farg1, int const *farg2, SwigArrayWrapper *farg3) { Tpetra::CrsGraph< LO,GO,NO > *arg1 = (Tpetra::CrsGraph< LO,GO,NO > *) 0 ; LO arg2 ; - std::pair< LO const *,std::size_t > arg3 ; + Teuchos::ArrayView< LO const > arg3 ; Teuchos::RCP< Tpetra::CrsGraph< LO,GO,NO > > *smartarg1 ; + int const *tempbegin3 ; smartarg1 = static_cast< Teuchos::RCP< Tpetra::CrsGraph >* >(farg1->cptr); arg1 = smartarg1 ? const_cast< Tpetra::CrsGraph* >(smartarg1->get()) : NULL; arg2 = *farg2 - 1; - (&arg3)->first = static_cast(farg3->data); - (&arg3)->second = farg3->size; + tempbegin3 = static_cast(farg3->data); + arg3 = Teuchos::ArrayView(tempbegin3, farg3->size); { // Make sure no unhandled exceptions exist before performing a new action - SWIG_check_unhandled_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::insertLocalIndices(LO const,std::pair< LO const *,std::size_t >)");; + SWIG_check_unhandled_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::insertLocalIndices(LO const,Teuchos::ArrayView< LO const >)");; try { // Attempt the wrapped function call @@ -9911,78 +9926,39 @@ SWIGEXPORT void _wrap_TpetraCrsGraph_insertLocalIndices(SwigClassWrapper const * catch (const std::range_error& e) { // Store a C++ exception - SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::insertLocalIndices(LO const,std::pair< LO const *,std::size_t >)", SWIG_IndexError, e.what(), return ); + SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::insertLocalIndices(LO const,Teuchos::ArrayView< LO const >)", SWIG_IndexError, e.what(), return ); } catch (const std::exception& e) { // Store a C++ exception - SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::insertLocalIndices(LO const,std::pair< LO const *,std::size_t >)", SWIG_RuntimeError, e.what(), return ); + SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::insertLocalIndices(LO const,Teuchos::ArrayView< LO const >)", SWIG_RuntimeError, e.what(), return ); } catch (...) { - SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::insertLocalIndices(LO const,std::pair< LO const *,std::size_t >)", SWIG_UnknownError, "An unknown exception occurred", return ); + SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::insertLocalIndices(LO const,Teuchos::ArrayView< LO const >)", SWIG_UnknownError, "An unknown exception occurred", return ); } } } -SWIGEXPORT void _wrap_TpetraCrsGraph_getGlobalRowCopy(SwigClassWrapper const *farg1, long long const *farg2, SwigArrayWrapper *farg3, size_t *farg4) { +SWIGEXPORT void _wrap_TpetraCrsGraph_getLocalRowCopy(SwigClassWrapper const *farg1, int const *farg2, SwigArrayWrapper *farg3, size_t *farg4) { Tpetra::CrsGraph< LO,GO,NO > *arg1 = (Tpetra::CrsGraph< LO,GO,NO > *) 0 ; - GO arg2 ; - std::pair< GO *,std::size_t > arg3 ; - size_t *arg4 = 0 ; - Teuchos::RCP< Tpetra::CrsGraph< LO,GO,NO > const > *smartarg1 ; - - smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); - arg1 = smartarg1 ? const_cast< Tpetra::CrsGraph* >(smartarg1->get()) : NULL; - arg2 = static_cast< GO >(*farg2); - (&arg3)->first = static_cast(farg3->data); - (&arg3)->second = farg3->size; - arg4 = reinterpret_cast< size_t * >(farg4); - { - // Make sure no unhandled exceptions exist before performing a new action - SWIG_check_unhandled_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::getGlobalRowCopy(GO,std::pair< GO *,std::size_t >,size_t &) const");; - try - { - // Attempt the wrapped function call - Tpetra_CrsGraph_Sl_LO_Sc_GO_Sc_NO_Sg__getGlobalRowCopy((Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const *)arg1,arg2,arg3,*arg4); - } - catch (const std::range_error& e) - { - // Store a C++ exception - SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::getGlobalRowCopy(GO,std::pair< GO *,std::size_t >,size_t &) const", SWIG_IndexError, e.what(), return ); - } - catch (const std::exception& e) - { - // Store a C++ exception - SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::getGlobalRowCopy(GO,std::pair< GO *,std::size_t >,size_t &) const", SWIG_RuntimeError, e.what(), return ); - } - catch (...) - { - SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::getGlobalRowCopy(GO,std::pair< GO *,std::size_t >,size_t &) const", SWIG_UnknownError, "An unknown exception occurred", return ); - } - } - -} - - -SWIGEXPORT void _wrap_TpetraCrsGraph_getLocalRowCopy(SwigClassWrapper const *farg1, int const *farg2, SwigArrayWrapper *farg3, size_t *farg4) { - Tpetra::CrsGraph< LO,GO,NO > *arg1 = (Tpetra::CrsGraph< LO,GO,NO > *) 0 ; - LO arg2 ; - std::pair< LO *,std::size_t > arg3 ; + LO arg2 ; + Teuchos::ArrayView< LO > arg3 ; size_t *arg4 = 0 ; Teuchos::RCP< Tpetra::CrsGraph< LO,GO,NO > const > *smartarg1 ; + int *tempbegin3 ; smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); arg1 = smartarg1 ? const_cast< Tpetra::CrsGraph* >(smartarg1->get()) : NULL; arg2 = *farg2 - 1; - (&arg3)->first = static_cast(farg3->data); - (&arg3)->second = farg3->size; + tempbegin3 = static_cast(farg3->data); + arg3 = Teuchos::ArrayView(tempbegin3, farg3->size); arg4 = reinterpret_cast< size_t * >(farg4); { // Make sure no unhandled exceptions exist before performing a new action - SWIG_check_unhandled_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::getLocalRowCopy(LO,std::pair< LO *,std::size_t >,size_t &) const");; + SWIG_check_unhandled_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::getLocalRowCopy(LO,Teuchos::ArrayView< LO >,size_t &) const");; try { // Attempt the wrapped function call @@ -9991,54 +9967,16 @@ SWIGEXPORT void _wrap_TpetraCrsGraph_getLocalRowCopy(SwigClassWrapper const *far catch (const std::range_error& e) { // Store a C++ exception - SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::getLocalRowCopy(LO,std::pair< LO *,std::size_t >,size_t &) const", SWIG_IndexError, e.what(), return ); - } - catch (const std::exception& e) - { - // Store a C++ exception - SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::getLocalRowCopy(LO,std::pair< LO *,std::size_t >,size_t &) const", SWIG_RuntimeError, e.what(), return ); - } - catch (...) - { - SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::getLocalRowCopy(LO,std::pair< LO *,std::size_t >,size_t &) const", SWIG_UnknownError, "An unknown exception occurred", return ); - } - } - -} - - -SWIGEXPORT void _wrap_TpetraCrsGraph_getGlobalRowView(SwigClassWrapper const *farg1, long long const *farg2, SwigArrayWrapper *farg3) { - Tpetra::CrsGraph< LO,GO,NO > *arg1 = (Tpetra::CrsGraph< LO,GO,NO > *) 0 ; - GO arg2 ; - std::pair< GO const *,std::size_t > arg3 ; - Teuchos::RCP< Tpetra::CrsGraph< LO,GO,NO > const > *smartarg1 ; - - smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); - arg1 = smartarg1 ? const_cast< Tpetra::CrsGraph* >(smartarg1->get()) : NULL; - arg2 = static_cast< GO >(*farg2); - (&arg3)->first = static_cast(farg3->data); - (&arg3)->second = farg3->size; - { - // Make sure no unhandled exceptions exist before performing a new action - SWIG_check_unhandled_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::getGlobalRowView(GO const,std::pair< GO const *,std::size_t >) const");; - try - { - // Attempt the wrapped function call - Tpetra_CrsGraph_Sl_LO_Sc_GO_Sc_NO_Sg__getGlobalRowView((Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const *)arg1,arg2,arg3); - } - catch (const std::range_error& e) - { - // Store a C++ exception - SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::getGlobalRowView(GO const,std::pair< GO const *,std::size_t >) const", SWIG_IndexError, e.what(), return ); + SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::getLocalRowCopy(LO,Teuchos::ArrayView< LO >,size_t &) const", SWIG_IndexError, e.what(), return ); } catch (const std::exception& e) { // Store a C++ exception - SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::getGlobalRowView(GO const,std::pair< GO const *,std::size_t >) const", SWIG_RuntimeError, e.what(), return ); + SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::getLocalRowCopy(LO,Teuchos::ArrayView< LO >,size_t &) const", SWIG_RuntimeError, e.what(), return ); } catch (...) { - SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::getGlobalRowView(GO const,std::pair< GO const *,std::size_t >) const", SWIG_UnknownError, "An unknown exception occurred", return ); + SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::getLocalRowCopy(LO,Teuchos::ArrayView< LO >,size_t &) const", SWIG_UnknownError, "An unknown exception occurred", return ); } } @@ -10047,22 +9985,25 @@ SWIGEXPORT void _wrap_TpetraCrsGraph_getGlobalRowView(SwigClassWrapper const *fa SWIGEXPORT void _wrap_TpetraCrsGraph_setAllIndices(SwigClassWrapper const *farg1, SwigArrayWrapper *farg2, SwigArrayWrapper *farg3, SwigArrayWrapper *farg4) { Tpetra::CrsGraph< LO,GO,NO > *arg1 = (Tpetra::CrsGraph< LO,GO,NO > *) 0 ; - std::pair< std::size_t *,std::size_t > arg2 ; - std::pair< LO *,std::size_t > arg3 ; - std::pair< SC *,std::size_t > arg4 ; + Teuchos::ArrayView< std::size_t > arg2 ; + Teuchos::ArrayView< LO > arg3 ; + Teuchos::ArrayView< SC > arg4 ; Teuchos::RCP< Tpetra::CrsGraph< LO,GO,NO > > *smartarg1 ; + unsigned long *tempbegin2 ; + int *tempbegin3 ; + double *tempbegin4 ; smartarg1 = static_cast< Teuchos::RCP< Tpetra::CrsGraph >* >(farg1->cptr); arg1 = smartarg1 ? const_cast< Tpetra::CrsGraph* >(smartarg1->get()) : NULL; - (&arg2)->first = static_cast(farg2->data); - (&arg2)->second = farg2->size; - (&arg3)->first = static_cast(farg3->data); - (&arg3)->second = farg3->size; - (&arg4)->first = static_cast(farg4->data); - (&arg4)->second = farg4->size; + tempbegin2 = static_cast(farg2->data); + arg2 = Teuchos::ArrayView(tempbegin2, farg2->size); + tempbegin3 = static_cast(farg3->data); + arg3 = Teuchos::ArrayView(tempbegin3, farg3->size); + tempbegin4 = static_cast(farg4->data); + arg4 = Teuchos::ArrayView(tempbegin4, farg4->size); { // Make sure no unhandled exceptions exist before performing a new action - SWIG_check_unhandled_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::setAllIndices(std::pair< std::size_t *,std::size_t >,std::pair< LO *,std::size_t >,std::pair< SC *,std::size_t >)");; + SWIG_check_unhandled_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::setAllIndices(Teuchos::ArrayView< std::size_t >,Teuchos::ArrayView< LO >,Teuchos::ArrayView< SC >)");; try { // Attempt the wrapped function call @@ -10071,16 +10012,16 @@ SWIGEXPORT void _wrap_TpetraCrsGraph_setAllIndices(SwigClassWrapper const *farg1 catch (const std::range_error& e) { // Store a C++ exception - SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::setAllIndices(std::pair< std::size_t *,std::size_t >,std::pair< LO *,std::size_t >,std::pair< SC *,std::size_t >)", SWIG_IndexError, e.what(), return ); + SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::setAllIndices(Teuchos::ArrayView< std::size_t >,Teuchos::ArrayView< LO >,Teuchos::ArrayView< SC >)", SWIG_IndexError, e.what(), return ); } catch (const std::exception& e) { // Store a C++ exception - SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::setAllIndices(std::pair< std::size_t *,std::size_t >,std::pair< LO *,std::size_t >,std::pair< SC *,std::size_t >)", SWIG_RuntimeError, e.what(), return ); + SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::setAllIndices(Teuchos::ArrayView< std::size_t >,Teuchos::ArrayView< LO >,Teuchos::ArrayView< SC >)", SWIG_RuntimeError, e.what(), return ); } catch (...) { - SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::setAllIndices(std::pair< std::size_t *,std::size_t >,std::pair< LO *,std::size_t >,std::pair< SC *,std::size_t >)", SWIG_UnknownError, "An unknown exception occurred", return ); + SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::setAllIndices(Teuchos::ArrayView< std::size_t >,Teuchos::ArrayView< LO >,Teuchos::ArrayView< SC >)", SWIG_UnknownError, "An unknown exception occurred", return ); } } @@ -10089,16 +10030,17 @@ SWIGEXPORT void _wrap_TpetraCrsGraph_setAllIndices(SwigClassWrapper const *farg1 SWIGEXPORT void _wrap_TpetraCrsGraph_getNodeRowPtrs(SwigClassWrapper const *farg1, SwigArrayWrapper *farg2) { Tpetra::CrsGraph< LO,GO,NO > *arg1 = (Tpetra::CrsGraph< LO,GO,NO > *) 0 ; - std::pair< std::size_t *,std::size_t > arg2 ; + Teuchos::ArrayView< std::size_t > arg2 ; Teuchos::RCP< Tpetra::CrsGraph< LO,GO,NO > const > *smartarg1 ; + unsigned long *tempbegin2 ; smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); arg1 = smartarg1 ? const_cast< Tpetra::CrsGraph* >(smartarg1->get()) : NULL; - (&arg2)->first = static_cast(farg2->data); - (&arg2)->second = farg2->size; + tempbegin2 = static_cast(farg2->data); + arg2 = Teuchos::ArrayView(tempbegin2, farg2->size); { // Make sure no unhandled exceptions exist before performing a new action - SWIG_check_unhandled_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::getNodeRowPtrs(std::pair< std::size_t *,std::size_t >) const");; + SWIG_check_unhandled_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::getNodeRowPtrs(Teuchos::ArrayView< std::size_t >) const");; try { // Attempt the wrapped function call @@ -10107,16 +10049,16 @@ SWIGEXPORT void _wrap_TpetraCrsGraph_getNodeRowPtrs(SwigClassWrapper const *farg catch (const std::range_error& e) { // Store a C++ exception - SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::getNodeRowPtrs(std::pair< std::size_t *,std::size_t >) const", SWIG_IndexError, e.what(), return ); + SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::getNodeRowPtrs(Teuchos::ArrayView< std::size_t >) const", SWIG_IndexError, e.what(), return ); } catch (const std::exception& e) { // Store a C++ exception - SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::getNodeRowPtrs(std::pair< std::size_t *,std::size_t >) const", SWIG_RuntimeError, e.what(), return ); + SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::getNodeRowPtrs(Teuchos::ArrayView< std::size_t >) const", SWIG_RuntimeError, e.what(), return ); } catch (...) { - SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::getNodeRowPtrs(std::pair< std::size_t *,std::size_t >) const", SWIG_UnknownError, "An unknown exception occurred", return ); + SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::getNodeRowPtrs(Teuchos::ArrayView< std::size_t >) const", SWIG_UnknownError, "An unknown exception occurred", return ); } } @@ -10125,16 +10067,17 @@ SWIGEXPORT void _wrap_TpetraCrsGraph_getNodeRowPtrs(SwigClassWrapper const *farg SWIGEXPORT void _wrap_TpetraCrsGraph_getNodePackedIndices(SwigClassWrapper const *farg1, SwigArrayWrapper *farg2) { Tpetra::CrsGraph< LO,GO,NO > *arg1 = (Tpetra::CrsGraph< LO,GO,NO > *) 0 ; - std::pair< std::size_t *,std::size_t > arg2 ; + Teuchos::ArrayView< std::size_t > arg2 ; Teuchos::RCP< Tpetra::CrsGraph< LO,GO,NO > const > *smartarg1 ; + unsigned long *tempbegin2 ; smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); arg1 = smartarg1 ? const_cast< Tpetra::CrsGraph* >(smartarg1->get()) : NULL; - (&arg2)->first = static_cast(farg2->data); - (&arg2)->second = farg2->size; + tempbegin2 = static_cast(farg2->data); + arg2 = Teuchos::ArrayView(tempbegin2, farg2->size); { // Make sure no unhandled exceptions exist before performing a new action - SWIG_check_unhandled_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::getNodePackedIndices(std::pair< std::size_t *,std::size_t >) const");; + SWIG_check_unhandled_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::getNodePackedIndices(Teuchos::ArrayView< std::size_t >) const");; try { // Attempt the wrapped function call @@ -10143,52 +10086,16 @@ SWIGEXPORT void _wrap_TpetraCrsGraph_getNodePackedIndices(SwigClassWrapper const catch (const std::range_error& e) { // Store a C++ exception - SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::getNodePackedIndices(std::pair< std::size_t *,std::size_t >) const", SWIG_IndexError, e.what(), return ); - } - catch (const std::exception& e) - { - // Store a C++ exception - SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::getNodePackedIndices(std::pair< std::size_t *,std::size_t >) const", SWIG_RuntimeError, e.what(), return ); - } - catch (...) - { - SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::getNodePackedIndices(std::pair< std::size_t *,std::size_t >) const", SWIG_UnknownError, "An unknown exception occurred", return ); - } - } - -} - - -SWIGEXPORT void _wrap_TpetraCrsGraph_getLocalDiagOffsets(SwigClassWrapper const *farg1, SwigArrayWrapper *farg2) { - Tpetra::CrsGraph< LO,GO,NO > *arg1 = (Tpetra::CrsGraph< LO,GO,NO > *) 0 ; - std::pair< std::size_t *,std::size_t > arg2 ; - Teuchos::RCP< Tpetra::CrsGraph< LO,GO,NO > const > *smartarg1 ; - - smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); - arg1 = smartarg1 ? const_cast< Tpetra::CrsGraph* >(smartarg1->get()) : NULL; - (&arg2)->first = static_cast(farg2->data); - (&arg2)->second = farg2->size; - { - // Make sure no unhandled exceptions exist before performing a new action - SWIG_check_unhandled_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::getLocalDiagOffsets(std::pair< std::size_t *,std::size_t >) const");; - try - { - // Attempt the wrapped function call - Tpetra_CrsGraph_Sl_LO_Sc_GO_Sc_NO_Sg__getLocalDiagOffsets((Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const *)arg1,arg2); - } - catch (const std::range_error& e) - { - // Store a C++ exception - SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::getLocalDiagOffsets(std::pair< std::size_t *,std::size_t >) const", SWIG_IndexError, e.what(), return ); + SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::getNodePackedIndices(Teuchos::ArrayView< std::size_t >) const", SWIG_IndexError, e.what(), return ); } catch (const std::exception& e) { // Store a C++ exception - SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::getLocalDiagOffsets(std::pair< std::size_t *,std::size_t >) const", SWIG_RuntimeError, e.what(), return ); + SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::getNodePackedIndices(Teuchos::ArrayView< std::size_t >) const", SWIG_RuntimeError, e.what(), return ); } catch (...) { - SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::getLocalDiagOffsets(std::pair< std::size_t *,std::size_t >) const", SWIG_UnknownError, "An unknown exception occurred", return ); + SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::getNodePackedIndices(Teuchos::ArrayView< std::size_t >) const", SWIG_UnknownError, "An unknown exception occurred", return ); } } @@ -10823,6 +10730,103 @@ SWIGEXPORT void _wrap_delete_TpetraCrsMatrix(SwigClassWrapper const *farg1) { } +SWIGEXPORT void _wrap_TpetraCrsMatrix_insertGlobalValues(SwigClassWrapper const *farg1, long long const *farg2, SwigArrayWrapper *farg3, SwigArrayWrapper *farg4) { + Tpetra::CrsMatrix< SC,LO,GO,NO > *arg1 = (Tpetra::CrsMatrix< SC,LO,GO,NO > *) 0 ; + long long arg2 ; + Teuchos::ArrayView< long long const > *arg3 = 0 ; + Teuchos::ArrayView< double const > *arg4 = 0 ; + Teuchos::RCP< Tpetra::CrsMatrix< SC,LO,GO,NO > > *smartarg1 ; + long long const *tempbegin3 ; + Teuchos::ArrayView< long long const > temparr3 ; + double const *tempbegin4 ; + Teuchos::ArrayView< double const > temparr4 ; + + smartarg1 = static_cast< Teuchos::RCP< Tpetra::CrsMatrix >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::CrsMatrix* >(smartarg1->get()) : NULL; + arg2 = static_cast< long long >(*farg2); + tempbegin3 = static_cast(farg3->data); + temparr3 = Teuchos::ArrayView(tempbegin3, farg3->size); + arg3 = &temparr3; + tempbegin4 = static_cast(farg4->data); + temparr4 = Teuchos::ArrayView(tempbegin4, farg4->size); + arg4 = &temparr4; + { + // Make sure no unhandled exceptions exist before performing a new action + SWIG_check_unhandled_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::insertGlobalValues(long long const,Teuchos::ArrayView< long long const > const &,Teuchos::ArrayView< double const > const &)");; + try + { + // Attempt the wrapped function call + (arg1)->insertGlobalValues(arg2,(Teuchos::ArrayView< long long const > const &)*arg3,(Teuchos::ArrayView< double const > const &)*arg4); + } + catch (const std::range_error& e) + { + // Store a C++ exception + SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::insertGlobalValues(long long const,Teuchos::ArrayView< long long const > const &,Teuchos::ArrayView< double const > const &)", SWIG_IndexError, e.what(), return ); + } + catch (const std::exception& e) + { + // Store a C++ exception + SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::insertGlobalValues(long long const,Teuchos::ArrayView< long long const > const &,Teuchos::ArrayView< double const > const &)", SWIG_RuntimeError, e.what(), return ); + } + catch (...) + { + SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::insertGlobalValues(long long const,Teuchos::ArrayView< long long const > const &,Teuchos::ArrayView< double const > const &)", SWIG_UnknownError, "An unknown exception occurred", return ); + } + } + +} + + +SWIGEXPORT int _wrap_TpetraCrsMatrix_replaceGlobalValues(SwigClassWrapper const *farg1, long long const *farg2, SwigArrayWrapper *farg3, SwigArrayWrapper *farg4) { + int fresult ; + Tpetra::CrsMatrix< SC,LO,GO,NO > *arg1 = (Tpetra::CrsMatrix< SC,LO,GO,NO > *) 0 ; + long long arg2 ; + Teuchos::ArrayView< long long const > *arg3 = 0 ; + Teuchos::ArrayView< double const > *arg4 = 0 ; + Teuchos::RCP< Tpetra::CrsMatrix< SC,LO,GO,NO > const > *smartarg1 ; + long long const *tempbegin3 ; + Teuchos::ArrayView< long long const > temparr3 ; + double const *tempbegin4 ; + Teuchos::ArrayView< double const > temparr4 ; + int result; + + smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::CrsMatrix* >(smartarg1->get()) : NULL; + arg2 = static_cast< long long >(*farg2); + tempbegin3 = static_cast(farg3->data); + temparr3 = Teuchos::ArrayView(tempbegin3, farg3->size); + arg3 = &temparr3; + tempbegin4 = static_cast(farg4->data); + temparr4 = Teuchos::ArrayView(tempbegin4, farg4->size); + arg4 = &temparr4; + { + // Make sure no unhandled exceptions exist before performing a new action + SWIG_check_unhandled_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::replaceGlobalValues(long long const,Teuchos::ArrayView< long long const > const &,Teuchos::ArrayView< double const > const &) const");; + try + { + // Attempt the wrapped function call + result = (int)((Tpetra::CrsMatrix< SC,LO,GO,NO > const *)arg1)->replaceGlobalValues(arg2,(Teuchos::ArrayView< long long const > const &)*arg3,(Teuchos::ArrayView< double const > const &)*arg4); + } + catch (const std::range_error& e) + { + // Store a C++ exception + SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::replaceGlobalValues(long long const,Teuchos::ArrayView< long long const > const &,Teuchos::ArrayView< double const > const &) const", SWIG_IndexError, e.what(), return 0); + } + catch (const std::exception& e) + { + // Store a C++ exception + SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::replaceGlobalValues(long long const,Teuchos::ArrayView< long long const > const &,Teuchos::ArrayView< double const > const &) const", SWIG_RuntimeError, e.what(), return 0); + } + catch (...) + { + SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::replaceGlobalValues(long long const,Teuchos::ArrayView< long long const > const &,Teuchos::ArrayView< double const > const &) const", SWIG_UnknownError, "An unknown exception occurred", return 0); + } + } + fresult = static_cast< int >(result); + return fresult; +} + + SWIGEXPORT void _wrap_TpetraCrsMatrix_setAllToScalar(SwigClassWrapper const *farg1, double const *farg2) { Tpetra::CrsMatrix< SC,LO,GO,NO > *arg1 = (Tpetra::CrsMatrix< SC,LO,GO,NO > *) 0 ; double *arg2 = 0 ; @@ -12578,6 +12582,96 @@ SWIGEXPORT int _wrap_TpetraCrsMatrix_supportsRowViews(SwigClassWrapper const *fa } +SWIGEXPORT void _wrap_TpetraCrsMatrix_getGlobalRowCopy(SwigClassWrapper const *farg1, long long const *farg2, SwigArrayWrapper *farg3, SwigArrayWrapper *farg4, size_t *farg5) { + Tpetra::CrsMatrix< SC,LO,GO,NO > *arg1 = (Tpetra::CrsMatrix< SC,LO,GO,NO > *) 0 ; + long long arg2 ; + Teuchos::ArrayView< long long > *arg3 = 0 ; + Teuchos::ArrayView< double > *arg4 = 0 ; + size_t *arg5 = 0 ; + Teuchos::RCP< Tpetra::CrsMatrix< SC,LO,GO,NO > const > *smartarg1 ; + long long *tempbegin3 ; + Teuchos::ArrayView< long long > temparr3 ; + double *tempbegin4 ; + Teuchos::ArrayView< double > temparr4 ; + + smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::CrsMatrix* >(smartarg1->get()) : NULL; + arg2 = static_cast< long long >(*farg2); + tempbegin3 = static_cast(farg3->data); + temparr3 = Teuchos::ArrayView(tempbegin3, farg3->size); + arg3 = &temparr3; + tempbegin4 = static_cast(farg4->data); + temparr4 = Teuchos::ArrayView(tempbegin4, farg4->size); + arg4 = &temparr4; + arg5 = reinterpret_cast< size_t * >(farg5); + { + // Make sure no unhandled exceptions exist before performing a new action + SWIG_check_unhandled_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::getGlobalRowCopy(long long,Teuchos::ArrayView< long long > const &,Teuchos::ArrayView< double > const &,size_t &) const");; + try + { + // Attempt the wrapped function call + ((Tpetra::CrsMatrix< SC,LO,GO,NO > const *)arg1)->getGlobalRowCopy(arg2,(Teuchos::ArrayView< long long > const &)*arg3,(Teuchos::ArrayView< double > const &)*arg4,*arg5); + } + catch (const std::range_error& e) + { + // Store a C++ exception + SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::getGlobalRowCopy(long long,Teuchos::ArrayView< long long > const &,Teuchos::ArrayView< double > const &,size_t &) const", SWIG_IndexError, e.what(), return ); + } + catch (const std::exception& e) + { + // Store a C++ exception + SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::getGlobalRowCopy(long long,Teuchos::ArrayView< long long > const &,Teuchos::ArrayView< double > const &,size_t &) const", SWIG_RuntimeError, e.what(), return ); + } + catch (...) + { + SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::getGlobalRowCopy(long long,Teuchos::ArrayView< long long > const &,Teuchos::ArrayView< double > const &,size_t &) const", SWIG_UnknownError, "An unknown exception occurred", return ); + } + } + +} + + +SWIGEXPORT void _wrap_TpetraCrsMatrix_getGlobalRowView(SwigClassWrapper const *farg1, long long const *farg2, SwigClassWrapper const *farg3, SwigClassWrapper const *farg4) { + Tpetra::CrsMatrix< SC,LO,GO,NO > *arg1 = (Tpetra::CrsMatrix< SC,LO,GO,NO > *) 0 ; + long long arg2 ; + Teuchos::ArrayView< long long const > *arg3 = 0 ; + Teuchos::ArrayView< double const > *arg4 = 0 ; + Teuchos::RCP< Tpetra::CrsMatrix< SC,LO,GO,NO > const > *smartarg1 ; + + smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::CrsMatrix* >(smartarg1->get()) : NULL; + arg2 = static_cast< long long >(*farg2); + SWIG_check_mutable_nonnull(*farg3, "Teuchos::ArrayView< long long const > &", "SWIGTYPE_Teuchos__ArrayViewT_long_long_const_t", "Tpetra::CrsMatrix< SC,LO,GO,NO >::getGlobalRowView(long long,Teuchos::ArrayView< long long const > &,Teuchos::ArrayView< double const > &) const", return ); + arg3 = static_cast< Teuchos::ArrayView< long long const > * >(farg3->cptr); + SWIG_check_mutable_nonnull(*farg4, "Teuchos::ArrayView< double const > &", "SWIGTYPE_Teuchos__ArrayViewT_double_const_t", "Tpetra::CrsMatrix< SC,LO,GO,NO >::getGlobalRowView(long long,Teuchos::ArrayView< long long const > &,Teuchos::ArrayView< double const > &) const", return ); + arg4 = static_cast< Teuchos::ArrayView< double const > * >(farg4->cptr); + { + // Make sure no unhandled exceptions exist before performing a new action + SWIG_check_unhandled_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::getGlobalRowView(long long,Teuchos::ArrayView< long long const > &,Teuchos::ArrayView< double const > &) const");; + try + { + // Attempt the wrapped function call + ((Tpetra::CrsMatrix< SC,LO,GO,NO > const *)arg1)->getGlobalRowView(arg2,*arg3,*arg4); + } + catch (const std::range_error& e) + { + // Store a C++ exception + SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::getGlobalRowView(long long,Teuchos::ArrayView< long long const > &,Teuchos::ArrayView< double const > &) const", SWIG_IndexError, e.what(), return ); + } + catch (const std::exception& e) + { + // Store a C++ exception + SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::getGlobalRowView(long long,Teuchos::ArrayView< long long const > &,Teuchos::ArrayView< double const > &) const", SWIG_RuntimeError, e.what(), return ); + } + catch (...) + { + SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::getGlobalRowView(long long,Teuchos::ArrayView< long long const > &,Teuchos::ArrayView< double const > &) const", SWIG_UnknownError, "An unknown exception occurred", return ); + } + } + +} + + SWIGEXPORT void _wrap_TpetraCrsMatrix_apply__SWIG_0(SwigClassWrapper const *farg1, SwigClassWrapper const *farg2, SwigClassWrapper const *farg3, int const *farg4, double const *farg5, double const *farg6) { Tpetra::CrsMatrix< SC,LO,GO,NO > *arg1 = (Tpetra::CrsMatrix< SC,LO,GO,NO > *) 0 ; Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > *arg2 = 0 ; @@ -13489,21 +13583,22 @@ SWIGEXPORT int _wrap_TpetraCrsMatrix_haveGlobalConstants(SwigClassWrapper const SWIGEXPORT SwigClassWrapper _wrap_new_TpetraCrsMatrix__SWIG_10(SwigClassWrapper const *farg1, SwigArrayWrapper *farg2, int const *farg3, SwigClassWrapper const *farg4) { SwigClassWrapper fresult ; Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > *arg1 = 0 ; - std::pair< std::size_t const *,std::size_t > arg2 ; + Teuchos::ArrayView< std::size_t const > arg2 ; Tpetra::ProfileType arg3 ; Teuchos::RCP< Teuchos::ParameterList > *arg4 = 0 ; Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > tempnull1 ; + unsigned long const *tempbegin2 ; Teuchos::RCP< Teuchos::ParameterList > tempnull4 ; Tpetra::CrsMatrix< SC,LO,GO,NO > *result = 0 ; arg1 = farg1->cptr ? static_cast< Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg1->cptr) : &tempnull1; - (&arg2)->first = static_cast(farg2->data); - (&arg2)->second = farg2->size; + tempbegin2 = static_cast(farg2->data); + arg2 = Teuchos::ArrayView(tempbegin2, farg2->size); arg3 = static_cast< Tpetra::ProfileType >(*farg3); arg4 = farg4->cptr ? static_cast< Teuchos::RCP< Teuchos::ParameterList > * >(farg4->cptr) : &tempnull4; { // Make sure no unhandled exceptions exist before performing a new action - SWIG_check_unhandled_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::CrsMatrix(Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,std::pair< std::size_t const *,std::size_t >,Tpetra::ProfileType,Teuchos::RCP< Teuchos::ParameterList > const &)");; + SWIG_check_unhandled_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::CrsMatrix(Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::ArrayView< std::size_t const >,Tpetra::ProfileType,Teuchos::RCP< Teuchos::ParameterList > const &)");; try { // Attempt the wrapped function call @@ -13512,16 +13607,16 @@ SWIGEXPORT SwigClassWrapper _wrap_new_TpetraCrsMatrix__SWIG_10(SwigClassWrapper catch (const std::range_error& e) { // Store a C++ exception - SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::CrsMatrix(Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,std::pair< std::size_t const *,std::size_t >,Tpetra::ProfileType,Teuchos::RCP< Teuchos::ParameterList > const &)", SWIG_IndexError, e.what(), return SwigClassWrapper_uninitialized()); + SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::CrsMatrix(Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::ArrayView< std::size_t const >,Tpetra::ProfileType,Teuchos::RCP< Teuchos::ParameterList > const &)", SWIG_IndexError, e.what(), return SwigClassWrapper_uninitialized()); } catch (const std::exception& e) { // Store a C++ exception - SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::CrsMatrix(Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,std::pair< std::size_t const *,std::size_t >,Tpetra::ProfileType,Teuchos::RCP< Teuchos::ParameterList > const &)", SWIG_RuntimeError, e.what(), return SwigClassWrapper_uninitialized()); + SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::CrsMatrix(Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::ArrayView< std::size_t const >,Tpetra::ProfileType,Teuchos::RCP< Teuchos::ParameterList > const &)", SWIG_RuntimeError, e.what(), return SwigClassWrapper_uninitialized()); } catch (...) { - SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::CrsMatrix(Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,std::pair< std::size_t const *,std::size_t >,Tpetra::ProfileType,Teuchos::RCP< Teuchos::ParameterList > const &)", SWIG_UnknownError, "An unknown exception occurred", return SwigClassWrapper_uninitialized()); + SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::CrsMatrix(Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::ArrayView< std::size_t const >,Tpetra::ProfileType,Teuchos::RCP< Teuchos::ParameterList > const &)", SWIG_UnknownError, "An unknown exception occurred", return SwigClassWrapper_uninitialized()); } } fresult.cptr = result ? new Teuchos::RCP< Tpetra::CrsMatrix >(result SWIG_NO_NULL_DELETER_1) : NULL; @@ -13533,18 +13628,19 @@ SWIGEXPORT SwigClassWrapper _wrap_new_TpetraCrsMatrix__SWIG_10(SwigClassWrapper SWIGEXPORT SwigClassWrapper _wrap_new_TpetraCrsMatrix__SWIG_11(SwigClassWrapper const *farg1, SwigArrayWrapper *farg2, int const *farg3) { SwigClassWrapper fresult ; Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > *arg1 = 0 ; - std::pair< std::size_t const *,std::size_t > arg2 ; + Teuchos::ArrayView< std::size_t const > arg2 ; Tpetra::ProfileType arg3 ; Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > tempnull1 ; + unsigned long const *tempbegin2 ; Tpetra::CrsMatrix< SC,LO,GO,NO > *result = 0 ; arg1 = farg1->cptr ? static_cast< Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg1->cptr) : &tempnull1; - (&arg2)->first = static_cast(farg2->data); - (&arg2)->second = farg2->size; + tempbegin2 = static_cast(farg2->data); + arg2 = Teuchos::ArrayView(tempbegin2, farg2->size); arg3 = static_cast< Tpetra::ProfileType >(*farg3); { // Make sure no unhandled exceptions exist before performing a new action - SWIG_check_unhandled_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::CrsMatrix(Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,std::pair< std::size_t const *,std::size_t >,Tpetra::ProfileType)");; + SWIG_check_unhandled_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::CrsMatrix(Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::ArrayView< std::size_t const >,Tpetra::ProfileType)");; try { // Attempt the wrapped function call @@ -13553,16 +13649,16 @@ SWIGEXPORT SwigClassWrapper _wrap_new_TpetraCrsMatrix__SWIG_11(SwigClassWrapper catch (const std::range_error& e) { // Store a C++ exception - SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::CrsMatrix(Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,std::pair< std::size_t const *,std::size_t >,Tpetra::ProfileType)", SWIG_IndexError, e.what(), return SwigClassWrapper_uninitialized()); + SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::CrsMatrix(Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::ArrayView< std::size_t const >,Tpetra::ProfileType)", SWIG_IndexError, e.what(), return SwigClassWrapper_uninitialized()); } catch (const std::exception& e) { // Store a C++ exception - SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::CrsMatrix(Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,std::pair< std::size_t const *,std::size_t >,Tpetra::ProfileType)", SWIG_RuntimeError, e.what(), return SwigClassWrapper_uninitialized()); + SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::CrsMatrix(Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::ArrayView< std::size_t const >,Tpetra::ProfileType)", SWIG_RuntimeError, e.what(), return SwigClassWrapper_uninitialized()); } catch (...) { - SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::CrsMatrix(Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,std::pair< std::size_t const *,std::size_t >,Tpetra::ProfileType)", SWIG_UnknownError, "An unknown exception occurred", return SwigClassWrapper_uninitialized()); + SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::CrsMatrix(Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::ArrayView< std::size_t const >,Tpetra::ProfileType)", SWIG_UnknownError, "An unknown exception occurred", return SwigClassWrapper_uninitialized()); } } fresult.cptr = result ? new Teuchos::RCP< Tpetra::CrsMatrix >(result SWIG_NO_NULL_DELETER_1) : NULL; @@ -13574,16 +13670,17 @@ SWIGEXPORT SwigClassWrapper _wrap_new_TpetraCrsMatrix__SWIG_11(SwigClassWrapper SWIGEXPORT SwigClassWrapper _wrap_new_TpetraCrsMatrix__SWIG_12(SwigClassWrapper const *farg1, SwigArrayWrapper *farg2) { SwigClassWrapper fresult ; Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > *arg1 = 0 ; - std::pair< std::size_t const *,std::size_t > arg2 ; + Teuchos::ArrayView< std::size_t const > arg2 ; Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > tempnull1 ; + unsigned long const *tempbegin2 ; Tpetra::CrsMatrix< SC,LO,GO,NO > *result = 0 ; arg1 = farg1->cptr ? static_cast< Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg1->cptr) : &tempnull1; - (&arg2)->first = static_cast(farg2->data); - (&arg2)->second = farg2->size; + tempbegin2 = static_cast(farg2->data); + arg2 = Teuchos::ArrayView(tempbegin2, farg2->size); { // Make sure no unhandled exceptions exist before performing a new action - SWIG_check_unhandled_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::CrsMatrix(Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,std::pair< std::size_t const *,std::size_t >)");; + SWIG_check_unhandled_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::CrsMatrix(Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::ArrayView< std::size_t const >)");; try { // Attempt the wrapped function call @@ -13592,16 +13689,16 @@ SWIGEXPORT SwigClassWrapper _wrap_new_TpetraCrsMatrix__SWIG_12(SwigClassWrapper catch (const std::range_error& e) { // Store a C++ exception - SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::CrsMatrix(Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,std::pair< std::size_t const *,std::size_t >)", SWIG_IndexError, e.what(), return SwigClassWrapper_uninitialized()); + SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::CrsMatrix(Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::ArrayView< std::size_t const >)", SWIG_IndexError, e.what(), return SwigClassWrapper_uninitialized()); } catch (const std::exception& e) { // Store a C++ exception - SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::CrsMatrix(Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,std::pair< std::size_t const *,std::size_t >)", SWIG_RuntimeError, e.what(), return SwigClassWrapper_uninitialized()); + SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::CrsMatrix(Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::ArrayView< std::size_t const >)", SWIG_RuntimeError, e.what(), return SwigClassWrapper_uninitialized()); } catch (...) { - SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::CrsMatrix(Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,std::pair< std::size_t const *,std::size_t >)", SWIG_UnknownError, "An unknown exception occurred", return SwigClassWrapper_uninitialized()); + SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::CrsMatrix(Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::ArrayView< std::size_t const >)", SWIG_UnknownError, "An unknown exception occurred", return SwigClassWrapper_uninitialized()); } } fresult.cptr = result ? new Teuchos::RCP< Tpetra::CrsMatrix >(result SWIG_NO_NULL_DELETER_1) : NULL; @@ -13614,23 +13711,24 @@ SWIGEXPORT SwigClassWrapper _wrap_new_TpetraCrsMatrix__SWIG_13(SwigClassWrapper SwigClassWrapper fresult ; Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > *arg1 = 0 ; Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > *arg2 = 0 ; - std::pair< std::size_t const *,std::size_t > arg3 ; + Teuchos::ArrayView< std::size_t const > arg3 ; Tpetra::ProfileType arg4 ; Teuchos::RCP< Teuchos::ParameterList > *arg5 = 0 ; Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > tempnull1 ; Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > tempnull2 ; + unsigned long const *tempbegin3 ; Teuchos::RCP< Teuchos::ParameterList > tempnull5 ; Tpetra::CrsMatrix< SC,LO,GO,NO > *result = 0 ; arg1 = farg1->cptr ? static_cast< Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg1->cptr) : &tempnull1; arg2 = farg2->cptr ? static_cast< Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg2->cptr) : &tempnull2; - (&arg3)->first = static_cast(farg3->data); - (&arg3)->second = farg3->size; + tempbegin3 = static_cast(farg3->data); + arg3 = Teuchos::ArrayView(tempbegin3, farg3->size); arg4 = static_cast< Tpetra::ProfileType >(*farg4); arg5 = farg5->cptr ? static_cast< Teuchos::RCP< Teuchos::ParameterList > * >(farg5->cptr) : &tempnull5; { // Make sure no unhandled exceptions exist before performing a new action - SWIG_check_unhandled_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::CrsMatrix(Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,std::pair< std::size_t const *,std::size_t >,Tpetra::ProfileType,Teuchos::RCP< Teuchos::ParameterList > const &)");; + SWIG_check_unhandled_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::CrsMatrix(Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::ArrayView< std::size_t const >,Tpetra::ProfileType,Teuchos::RCP< Teuchos::ParameterList > const &)");; try { // Attempt the wrapped function call @@ -13639,16 +13737,16 @@ SWIGEXPORT SwigClassWrapper _wrap_new_TpetraCrsMatrix__SWIG_13(SwigClassWrapper catch (const std::range_error& e) { // Store a C++ exception - SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::CrsMatrix(Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,std::pair< std::size_t const *,std::size_t >,Tpetra::ProfileType,Teuchos::RCP< Teuchos::ParameterList > const &)", SWIG_IndexError, e.what(), return SwigClassWrapper_uninitialized()); + SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::CrsMatrix(Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::ArrayView< std::size_t const >,Tpetra::ProfileType,Teuchos::RCP< Teuchos::ParameterList > const &)", SWIG_IndexError, e.what(), return SwigClassWrapper_uninitialized()); } catch (const std::exception& e) { // Store a C++ exception - SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::CrsMatrix(Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,std::pair< std::size_t const *,std::size_t >,Tpetra::ProfileType,Teuchos::RCP< Teuchos::ParameterList > const &)", SWIG_RuntimeError, e.what(), return SwigClassWrapper_uninitialized()); + SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::CrsMatrix(Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::ArrayView< std::size_t const >,Tpetra::ProfileType,Teuchos::RCP< Teuchos::ParameterList > const &)", SWIG_RuntimeError, e.what(), return SwigClassWrapper_uninitialized()); } catch (...) { - SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::CrsMatrix(Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,std::pair< std::size_t const *,std::size_t >,Tpetra::ProfileType,Teuchos::RCP< Teuchos::ParameterList > const &)", SWIG_UnknownError, "An unknown exception occurred", return SwigClassWrapper_uninitialized()); + SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::CrsMatrix(Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::ArrayView< std::size_t const >,Tpetra::ProfileType,Teuchos::RCP< Teuchos::ParameterList > const &)", SWIG_UnknownError, "An unknown exception occurred", return SwigClassWrapper_uninitialized()); } } fresult.cptr = result ? new Teuchos::RCP< Tpetra::CrsMatrix >(result SWIG_NO_NULL_DELETER_1) : NULL; @@ -13661,20 +13759,21 @@ SWIGEXPORT SwigClassWrapper _wrap_new_TpetraCrsMatrix__SWIG_14(SwigClassWrapper SwigClassWrapper fresult ; Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > *arg1 = 0 ; Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > *arg2 = 0 ; - std::pair< std::size_t const *,std::size_t > arg3 ; + Teuchos::ArrayView< std::size_t const > arg3 ; Tpetra::ProfileType arg4 ; Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > tempnull1 ; Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > tempnull2 ; + unsigned long const *tempbegin3 ; Tpetra::CrsMatrix< SC,LO,GO,NO > *result = 0 ; arg1 = farg1->cptr ? static_cast< Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg1->cptr) : &tempnull1; arg2 = farg2->cptr ? static_cast< Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg2->cptr) : &tempnull2; - (&arg3)->first = static_cast(farg3->data); - (&arg3)->second = farg3->size; + tempbegin3 = static_cast(farg3->data); + arg3 = Teuchos::ArrayView(tempbegin3, farg3->size); arg4 = static_cast< Tpetra::ProfileType >(*farg4); { // Make sure no unhandled exceptions exist before performing a new action - SWIG_check_unhandled_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::CrsMatrix(Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,std::pair< std::size_t const *,std::size_t >,Tpetra::ProfileType)");; + SWIG_check_unhandled_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::CrsMatrix(Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::ArrayView< std::size_t const >,Tpetra::ProfileType)");; try { // Attempt the wrapped function call @@ -13683,16 +13782,16 @@ SWIGEXPORT SwigClassWrapper _wrap_new_TpetraCrsMatrix__SWIG_14(SwigClassWrapper catch (const std::range_error& e) { // Store a C++ exception - SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::CrsMatrix(Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,std::pair< std::size_t const *,std::size_t >,Tpetra::ProfileType)", SWIG_IndexError, e.what(), return SwigClassWrapper_uninitialized()); + SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::CrsMatrix(Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::ArrayView< std::size_t const >,Tpetra::ProfileType)", SWIG_IndexError, e.what(), return SwigClassWrapper_uninitialized()); } catch (const std::exception& e) { // Store a C++ exception - SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::CrsMatrix(Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,std::pair< std::size_t const *,std::size_t >,Tpetra::ProfileType)", SWIG_RuntimeError, e.what(), return SwigClassWrapper_uninitialized()); + SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::CrsMatrix(Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::ArrayView< std::size_t const >,Tpetra::ProfileType)", SWIG_RuntimeError, e.what(), return SwigClassWrapper_uninitialized()); } catch (...) { - SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::CrsMatrix(Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,std::pair< std::size_t const *,std::size_t >,Tpetra::ProfileType)", SWIG_UnknownError, "An unknown exception occurred", return SwigClassWrapper_uninitialized()); + SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::CrsMatrix(Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::ArrayView< std::size_t const >,Tpetra::ProfileType)", SWIG_UnknownError, "An unknown exception occurred", return SwigClassWrapper_uninitialized()); } } fresult.cptr = result ? new Teuchos::RCP< Tpetra::CrsMatrix >(result SWIG_NO_NULL_DELETER_1) : NULL; @@ -13705,18 +13804,19 @@ SWIGEXPORT SwigClassWrapper _wrap_new_TpetraCrsMatrix__SWIG_15(SwigClassWrapper SwigClassWrapper fresult ; Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > *arg1 = 0 ; Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > *arg2 = 0 ; - std::pair< std::size_t const *,std::size_t > arg3 ; + Teuchos::ArrayView< std::size_t const > arg3 ; Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > tempnull1 ; Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > tempnull2 ; + unsigned long const *tempbegin3 ; Tpetra::CrsMatrix< SC,LO,GO,NO > *result = 0 ; arg1 = farg1->cptr ? static_cast< Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg1->cptr) : &tempnull1; arg2 = farg2->cptr ? static_cast< Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg2->cptr) : &tempnull2; - (&arg3)->first = static_cast(farg3->data); - (&arg3)->second = farg3->size; + tempbegin3 = static_cast(farg3->data); + arg3 = Teuchos::ArrayView(tempbegin3, farg3->size); { // Make sure no unhandled exceptions exist before performing a new action - SWIG_check_unhandled_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::CrsMatrix(Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,std::pair< std::size_t const *,std::size_t >)");; + SWIG_check_unhandled_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::CrsMatrix(Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::ArrayView< std::size_t const >)");; try { // Attempt the wrapped function call @@ -13725,16 +13825,16 @@ SWIGEXPORT SwigClassWrapper _wrap_new_TpetraCrsMatrix__SWIG_15(SwigClassWrapper catch (const std::range_error& e) { // Store a C++ exception - SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::CrsMatrix(Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,std::pair< std::size_t const *,std::size_t >)", SWIG_IndexError, e.what(), return SwigClassWrapper_uninitialized()); + SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::CrsMatrix(Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::ArrayView< std::size_t const >)", SWIG_IndexError, e.what(), return SwigClassWrapper_uninitialized()); } catch (const std::exception& e) { // Store a C++ exception - SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::CrsMatrix(Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,std::pair< std::size_t const *,std::size_t >)", SWIG_RuntimeError, e.what(), return SwigClassWrapper_uninitialized()); + SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::CrsMatrix(Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::ArrayView< std::size_t const >)", SWIG_RuntimeError, e.what(), return SwigClassWrapper_uninitialized()); } catch (...) { - SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::CrsMatrix(Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,std::pair< std::size_t const *,std::size_t >)", SWIG_UnknownError, "An unknown exception occurred", return SwigClassWrapper_uninitialized()); + SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::CrsMatrix(Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::ArrayView< std::size_t const >)", SWIG_UnknownError, "An unknown exception occurred", return SwigClassWrapper_uninitialized()); } } fresult.cptr = result ? new Teuchos::RCP< Tpetra::CrsMatrix >(result SWIG_NO_NULL_DELETER_1) : NULL; @@ -13747,27 +13847,30 @@ SWIGEXPORT SwigClassWrapper _wrap_new_TpetraCrsMatrix__SWIG_16(SwigClassWrapper SwigClassWrapper fresult ; Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > *arg1 = 0 ; Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > *arg2 = 0 ; - std::pair< std::size_t *,std::size_t > arg3 ; - std::pair< LO *,std::size_t > arg4 ; - std::pair< SC *,std::size_t > arg5 ; + Teuchos::ArrayView< std::size_t > arg3 ; + Teuchos::ArrayView< LO > arg4 ; + Teuchos::ArrayView< SC > arg5 ; Teuchos::RCP< Teuchos::ParameterList > *arg6 = 0 ; Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > tempnull1 ; Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > tempnull2 ; + unsigned long *tempbegin3 ; + int *tempbegin4 ; + double *tempbegin5 ; Teuchos::RCP< Teuchos::ParameterList > tempnull6 ; Tpetra::CrsMatrix< SC,LO,GO,NO > *result = 0 ; arg1 = farg1->cptr ? static_cast< Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg1->cptr) : &tempnull1; arg2 = farg2->cptr ? static_cast< Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg2->cptr) : &tempnull2; - (&arg3)->first = static_cast(farg3->data); - (&arg3)->second = farg3->size; - (&arg4)->first = static_cast(farg4->data); - (&arg4)->second = farg4->size; - (&arg5)->first = static_cast(farg5->data); - (&arg5)->second = farg5->size; + tempbegin3 = static_cast(farg3->data); + arg3 = Teuchos::ArrayView(tempbegin3, farg3->size); + tempbegin4 = static_cast(farg4->data); + arg4 = Teuchos::ArrayView(tempbegin4, farg4->size); + tempbegin5 = static_cast(farg5->data); + arg5 = Teuchos::ArrayView(tempbegin5, farg5->size); arg6 = farg6->cptr ? static_cast< Teuchos::RCP< Teuchos::ParameterList > * >(farg6->cptr) : &tempnull6; { // Make sure no unhandled exceptions exist before performing a new action - SWIG_check_unhandled_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::CrsMatrix(Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,std::pair< std::size_t *,std::size_t >,std::pair< LO *,std::size_t >,std::pair< SC *,std::size_t >,Teuchos::RCP< Teuchos::ParameterList > const &)");; + SWIG_check_unhandled_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::CrsMatrix(Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::ArrayView< std::size_t >,Teuchos::ArrayView< LO >,Teuchos::ArrayView< SC >,Teuchos::RCP< Teuchos::ParameterList > const &)");; try { // Attempt the wrapped function call @@ -13776,16 +13879,16 @@ SWIGEXPORT SwigClassWrapper _wrap_new_TpetraCrsMatrix__SWIG_16(SwigClassWrapper catch (const std::range_error& e) { // Store a C++ exception - SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::CrsMatrix(Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,std::pair< std::size_t *,std::size_t >,std::pair< LO *,std::size_t >,std::pair< SC *,std::size_t >,Teuchos::RCP< Teuchos::ParameterList > const &)", SWIG_IndexError, e.what(), return SwigClassWrapper_uninitialized()); + SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::CrsMatrix(Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::ArrayView< std::size_t >,Teuchos::ArrayView< LO >,Teuchos::ArrayView< SC >,Teuchos::RCP< Teuchos::ParameterList > const &)", SWIG_IndexError, e.what(), return SwigClassWrapper_uninitialized()); } catch (const std::exception& e) { // Store a C++ exception - SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::CrsMatrix(Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,std::pair< std::size_t *,std::size_t >,std::pair< LO *,std::size_t >,std::pair< SC *,std::size_t >,Teuchos::RCP< Teuchos::ParameterList > const &)", SWIG_RuntimeError, e.what(), return SwigClassWrapper_uninitialized()); + SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::CrsMatrix(Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::ArrayView< std::size_t >,Teuchos::ArrayView< LO >,Teuchos::ArrayView< SC >,Teuchos::RCP< Teuchos::ParameterList > const &)", SWIG_RuntimeError, e.what(), return SwigClassWrapper_uninitialized()); } catch (...) { - SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::CrsMatrix(Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,std::pair< std::size_t *,std::size_t >,std::pair< LO *,std::size_t >,std::pair< SC *,std::size_t >,Teuchos::RCP< Teuchos::ParameterList > const &)", SWIG_UnknownError, "An unknown exception occurred", return SwigClassWrapper_uninitialized()); + SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::CrsMatrix(Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::ArrayView< std::size_t >,Teuchos::ArrayView< LO >,Teuchos::ArrayView< SC >,Teuchos::RCP< Teuchos::ParameterList > const &)", SWIG_UnknownError, "An unknown exception occurred", return SwigClassWrapper_uninitialized()); } } fresult.cptr = result ? new Teuchos::RCP< Tpetra::CrsMatrix >(result SWIG_NO_NULL_DELETER_1) : NULL; @@ -13798,24 +13901,27 @@ SWIGEXPORT SwigClassWrapper _wrap_new_TpetraCrsMatrix__SWIG_17(SwigClassWrapper SwigClassWrapper fresult ; Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > *arg1 = 0 ; Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > *arg2 = 0 ; - std::pair< std::size_t *,std::size_t > arg3 ; - std::pair< LO *,std::size_t > arg4 ; - std::pair< SC *,std::size_t > arg5 ; + Teuchos::ArrayView< std::size_t > arg3 ; + Teuchos::ArrayView< LO > arg4 ; + Teuchos::ArrayView< SC > arg5 ; Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > tempnull1 ; Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > tempnull2 ; + unsigned long *tempbegin3 ; + int *tempbegin4 ; + double *tempbegin5 ; Tpetra::CrsMatrix< SC,LO,GO,NO > *result = 0 ; arg1 = farg1->cptr ? static_cast< Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg1->cptr) : &tempnull1; arg2 = farg2->cptr ? static_cast< Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg2->cptr) : &tempnull2; - (&arg3)->first = static_cast(farg3->data); - (&arg3)->second = farg3->size; - (&arg4)->first = static_cast(farg4->data); - (&arg4)->second = farg4->size; - (&arg5)->first = static_cast(farg5->data); - (&arg5)->second = farg5->size; + tempbegin3 = static_cast(farg3->data); + arg3 = Teuchos::ArrayView(tempbegin3, farg3->size); + tempbegin4 = static_cast(farg4->data); + arg4 = Teuchos::ArrayView(tempbegin4, farg4->size); + tempbegin5 = static_cast(farg5->data); + arg5 = Teuchos::ArrayView(tempbegin5, farg5->size); { // Make sure no unhandled exceptions exist before performing a new action - SWIG_check_unhandled_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::CrsMatrix(Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,std::pair< std::size_t *,std::size_t >,std::pair< LO *,std::size_t >,std::pair< SC *,std::size_t >)");; + SWIG_check_unhandled_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::CrsMatrix(Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::ArrayView< std::size_t >,Teuchos::ArrayView< LO >,Teuchos::ArrayView< SC >)");; try { // Attempt the wrapped function call @@ -13824,16 +13930,16 @@ SWIGEXPORT SwigClassWrapper _wrap_new_TpetraCrsMatrix__SWIG_17(SwigClassWrapper catch (const std::range_error& e) { // Store a C++ exception - SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::CrsMatrix(Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,std::pair< std::size_t *,std::size_t >,std::pair< LO *,std::size_t >,std::pair< SC *,std::size_t >)", SWIG_IndexError, e.what(), return SwigClassWrapper_uninitialized()); + SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::CrsMatrix(Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::ArrayView< std::size_t >,Teuchos::ArrayView< LO >,Teuchos::ArrayView< SC >)", SWIG_IndexError, e.what(), return SwigClassWrapper_uninitialized()); } catch (const std::exception& e) { // Store a C++ exception - SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::CrsMatrix(Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,std::pair< std::size_t *,std::size_t >,std::pair< LO *,std::size_t >,std::pair< SC *,std::size_t >)", SWIG_RuntimeError, e.what(), return SwigClassWrapper_uninitialized()); + SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::CrsMatrix(Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::ArrayView< std::size_t >,Teuchos::ArrayView< LO >,Teuchos::ArrayView< SC >)", SWIG_RuntimeError, e.what(), return SwigClassWrapper_uninitialized()); } catch (...) { - SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::CrsMatrix(Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,std::pair< std::size_t *,std::size_t >,std::pair< LO *,std::size_t >,std::pair< SC *,std::size_t >)", SWIG_UnknownError, "An unknown exception occurred", return SwigClassWrapper_uninitialized()); + SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::CrsMatrix(Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::ArrayView< std::size_t >,Teuchos::ArrayView< LO >,Teuchos::ArrayView< SC >)", SWIG_UnknownError, "An unknown exception occurred", return SwigClassWrapper_uninitialized()); } } fresult.cptr = result ? new Teuchos::RCP< Tpetra::CrsMatrix >(result SWIG_NO_NULL_DELETER_1) : NULL; @@ -13842,64 +13948,25 @@ SWIGEXPORT SwigClassWrapper _wrap_new_TpetraCrsMatrix__SWIG_17(SwigClassWrapper } -SWIGEXPORT void _wrap_TpetraCrsMatrix_insertGlobalValues(SwigClassWrapper const *farg1, long long const *farg2, SwigArrayWrapper *farg3, SwigArrayWrapper *farg4) { - Tpetra::CrsMatrix< SC,LO,GO,NO > *arg1 = (Tpetra::CrsMatrix< SC,LO,GO,NO > *) 0 ; - GO arg2 ; - std::pair< GO const *,std::size_t > arg3 ; - std::pair< SC const *,std::size_t > arg4 ; - Teuchos::RCP< Tpetra::CrsMatrix< SC,LO,GO,NO > > *smartarg1 ; - - smartarg1 = static_cast< Teuchos::RCP< Tpetra::CrsMatrix >* >(farg1->cptr); - arg1 = smartarg1 ? const_cast< Tpetra::CrsMatrix* >(smartarg1->get()) : NULL; - arg2 = static_cast< GO >(*farg2); - (&arg3)->first = static_cast(farg3->data); - (&arg3)->second = farg3->size; - (&arg4)->first = static_cast(farg4->data); - (&arg4)->second = farg4->size; - { - // Make sure no unhandled exceptions exist before performing a new action - SWIG_check_unhandled_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::insertGlobalValues(GO const,std::pair< GO const *,std::size_t >,std::pair< SC const *,std::size_t >)");; - try - { - // Attempt the wrapped function call - Tpetra_CrsMatrix_Sl_SC_Sc_LO_Sc_GO_Sc_NO_Sg__insertGlobalValues(arg1,arg2,arg3,arg4); - } - catch (const std::range_error& e) - { - // Store a C++ exception - SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::insertGlobalValues(GO const,std::pair< GO const *,std::size_t >,std::pair< SC const *,std::size_t >)", SWIG_IndexError, e.what(), return ); - } - catch (const std::exception& e) - { - // Store a C++ exception - SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::insertGlobalValues(GO const,std::pair< GO const *,std::size_t >,std::pair< SC const *,std::size_t >)", SWIG_RuntimeError, e.what(), return ); - } - catch (...) - { - SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::insertGlobalValues(GO const,std::pair< GO const *,std::size_t >,std::pair< SC const *,std::size_t >)", SWIG_UnknownError, "An unknown exception occurred", return ); - } - } - -} - - SWIGEXPORT void _wrap_TpetraCrsMatrix_insertLocalValues(SwigClassWrapper const *farg1, int const *farg2, SwigArrayWrapper *farg3, SwigArrayWrapper *farg4) { Tpetra::CrsMatrix< SC,LO,GO,NO > *arg1 = (Tpetra::CrsMatrix< SC,LO,GO,NO > *) 0 ; LO arg2 ; - std::pair< LO const *,std::size_t > arg3 ; - std::pair< SC const *,std::size_t > arg4 ; + Teuchos::ArrayView< LO const > arg3 ; + Teuchos::ArrayView< SC const > arg4 ; Teuchos::RCP< Tpetra::CrsMatrix< SC,LO,GO,NO > > *smartarg1 ; + int const *tempbegin3 ; + double const *tempbegin4 ; smartarg1 = static_cast< Teuchos::RCP< Tpetra::CrsMatrix >* >(farg1->cptr); arg1 = smartarg1 ? const_cast< Tpetra::CrsMatrix* >(smartarg1->get()) : NULL; arg2 = *farg2 - 1; - (&arg3)->first = static_cast(farg3->data); - (&arg3)->second = farg3->size; - (&arg4)->first = static_cast(farg4->data); - (&arg4)->second = farg4->size; + tempbegin3 = static_cast(farg3->data); + arg3 = Teuchos::ArrayView(tempbegin3, farg3->size); + tempbegin4 = static_cast(farg4->data); + arg4 = Teuchos::ArrayView(tempbegin4, farg4->size); { // Make sure no unhandled exceptions exist before performing a new action - SWIG_check_unhandled_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::insertLocalValues(LO const,std::pair< LO const *,std::size_t >,std::pair< SC const *,std::size_t >)");; + SWIG_check_unhandled_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::insertLocalValues(LO const,Teuchos::ArrayView< LO const >,Teuchos::ArrayView< SC const >)");; try { // Attempt the wrapped function call @@ -13908,85 +13975,43 @@ SWIGEXPORT void _wrap_TpetraCrsMatrix_insertLocalValues(SwigClassWrapper const * catch (const std::range_error& e) { // Store a C++ exception - SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::insertLocalValues(LO const,std::pair< LO const *,std::size_t >,std::pair< SC const *,std::size_t >)", SWIG_IndexError, e.what(), return ); + SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::insertLocalValues(LO const,Teuchos::ArrayView< LO const >,Teuchos::ArrayView< SC const >)", SWIG_IndexError, e.what(), return ); } catch (const std::exception& e) { // Store a C++ exception - SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::insertLocalValues(LO const,std::pair< LO const *,std::size_t >,std::pair< SC const *,std::size_t >)", SWIG_RuntimeError, e.what(), return ); + SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::insertLocalValues(LO const,Teuchos::ArrayView< LO const >,Teuchos::ArrayView< SC const >)", SWIG_RuntimeError, e.what(), return ); } catch (...) { - SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::insertLocalValues(LO const,std::pair< LO const *,std::size_t >,std::pair< SC const *,std::size_t >)", SWIG_UnknownError, "An unknown exception occurred", return ); + SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::insertLocalValues(LO const,Teuchos::ArrayView< LO const >,Teuchos::ArrayView< SC const >)", SWIG_UnknownError, "An unknown exception occurred", return ); } } } -SWIGEXPORT int _wrap_TpetraCrsMatrix_replaceGlobalValues(SwigClassWrapper const *farg1, long long const *farg2, SwigArrayWrapper *farg3, SwigArrayWrapper *farg4) { - int fresult ; - Tpetra::CrsMatrix< SC,LO,GO,NO > *arg1 = (Tpetra::CrsMatrix< SC,LO,GO,NO > *) 0 ; - GO arg2 ; - std::pair< GO const *,std::size_t > arg3 ; - std::pair< SC const *,std::size_t > arg4 ; - Teuchos::RCP< Tpetra::CrsMatrix< SC,LO,GO,NO > const > *smartarg1 ; - LO result; - - smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); - arg1 = smartarg1 ? const_cast< Tpetra::CrsMatrix* >(smartarg1->get()) : NULL; - arg2 = static_cast< GO >(*farg2); - (&arg3)->first = static_cast(farg3->data); - (&arg3)->second = farg3->size; - (&arg4)->first = static_cast(farg4->data); - (&arg4)->second = farg4->size; - { - // Make sure no unhandled exceptions exist before performing a new action - SWIG_check_unhandled_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::replaceGlobalValues(GO const,std::pair< GO const *,std::size_t >,std::pair< SC const *,std::size_t >) const");; - try - { - // Attempt the wrapped function call - result = (LO)Tpetra_CrsMatrix_Sl_SC_Sc_LO_Sc_GO_Sc_NO_Sg__replaceGlobalValues((Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const *)arg1,arg2,arg3,arg4); - } - catch (const std::range_error& e) - { - // Store a C++ exception - SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::replaceGlobalValues(GO const,std::pair< GO const *,std::size_t >,std::pair< SC const *,std::size_t >) const", SWIG_IndexError, e.what(), return 0); - } - catch (const std::exception& e) - { - // Store a C++ exception - SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::replaceGlobalValues(GO const,std::pair< GO const *,std::size_t >,std::pair< SC const *,std::size_t >) const", SWIG_RuntimeError, e.what(), return 0); - } - catch (...) - { - SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::replaceGlobalValues(GO const,std::pair< GO const *,std::size_t >,std::pair< SC const *,std::size_t >) const", SWIG_UnknownError, "An unknown exception occurred", return 0); - } - } - fresult = static_cast< LO >(result); - return fresult; -} - - SWIGEXPORT int _wrap_TpetraCrsMatrix_sumIntoGlobalValues(SwigClassWrapper const *farg1, long long const *farg2, SwigArrayWrapper *farg3, SwigArrayWrapper *farg4) { int fresult ; Tpetra::CrsMatrix< SC,LO,GO,NO > *arg1 = (Tpetra::CrsMatrix< SC,LO,GO,NO > *) 0 ; GO arg2 ; - std::pair< GO const *,std::size_t > arg3 ; - std::pair< SC const *,std::size_t > arg4 ; + Teuchos::ArrayView< GO const > arg3 ; + Teuchos::ArrayView< SC const > arg4 ; Teuchos::RCP< Tpetra::CrsMatrix< SC,LO,GO,NO > > *smartarg1 ; + long long const *tempbegin3 ; + double const *tempbegin4 ; LO result; smartarg1 = static_cast< Teuchos::RCP< Tpetra::CrsMatrix >* >(farg1->cptr); arg1 = smartarg1 ? const_cast< Tpetra::CrsMatrix* >(smartarg1->get()) : NULL; arg2 = static_cast< GO >(*farg2); - (&arg3)->first = static_cast(farg3->data); - (&arg3)->second = farg3->size; - (&arg4)->first = static_cast(farg4->data); - (&arg4)->second = farg4->size; + tempbegin3 = static_cast(farg3->data); + arg3 = Teuchos::ArrayView(tempbegin3, farg3->size); + tempbegin4 = static_cast(farg4->data); + arg4 = Teuchos::ArrayView(tempbegin4, farg4->size); { // Make sure no unhandled exceptions exist before performing a new action - SWIG_check_unhandled_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::sumIntoGlobalValues(GO const,std::pair< GO const *,std::size_t >,std::pair< SC const *,std::size_t >)");; + SWIG_check_unhandled_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::sumIntoGlobalValues(GO const,Teuchos::ArrayView< GO const >,Teuchos::ArrayView< SC const >)");; try { // Attempt the wrapped function call @@ -13995,16 +14020,16 @@ SWIGEXPORT int _wrap_TpetraCrsMatrix_sumIntoGlobalValues(SwigClassWrapper const catch (const std::range_error& e) { // Store a C++ exception - SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::sumIntoGlobalValues(GO const,std::pair< GO const *,std::size_t >,std::pair< SC const *,std::size_t >)", SWIG_IndexError, e.what(), return 0); + SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::sumIntoGlobalValues(GO const,Teuchos::ArrayView< GO const >,Teuchos::ArrayView< SC const >)", SWIG_IndexError, e.what(), return 0); } catch (const std::exception& e) { // Store a C++ exception - SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::sumIntoGlobalValues(GO const,std::pair< GO const *,std::size_t >,std::pair< SC const *,std::size_t >)", SWIG_RuntimeError, e.what(), return 0); + SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::sumIntoGlobalValues(GO const,Teuchos::ArrayView< GO const >,Teuchos::ArrayView< SC const >)", SWIG_RuntimeError, e.what(), return 0); } catch (...) { - SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::sumIntoGlobalValues(GO const,std::pair< GO const *,std::size_t >,std::pair< SC const *,std::size_t >)", SWIG_UnknownError, "An unknown exception occurred", return 0); + SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::sumIntoGlobalValues(GO const,Teuchos::ArrayView< GO const >,Teuchos::ArrayView< SC const >)", SWIG_UnknownError, "An unknown exception occurred", return 0); } } fresult = static_cast< LO >(result); @@ -14014,22 +14039,25 @@ SWIGEXPORT int _wrap_TpetraCrsMatrix_sumIntoGlobalValues(SwigClassWrapper const SWIGEXPORT void _wrap_TpetraCrsMatrix_setAllValues(SwigClassWrapper const *farg1, SwigArrayWrapper *farg2, SwigArrayWrapper *farg3, SwigArrayWrapper *farg4) { Tpetra::CrsMatrix< SC,LO,GO,NO > *arg1 = (Tpetra::CrsMatrix< SC,LO,GO,NO > *) 0 ; - std::pair< std::size_t *,std::size_t > arg2 ; - std::pair< LO *,std::size_t > arg3 ; - std::pair< SC *,std::size_t > arg4 ; + Teuchos::ArrayView< std::size_t > arg2 ; + Teuchos::ArrayView< LO > arg3 ; + Teuchos::ArrayView< SC > arg4 ; Teuchos::RCP< Tpetra::CrsMatrix< SC,LO,GO,NO > > *smartarg1 ; + unsigned long *tempbegin2 ; + int *tempbegin3 ; + double *tempbegin4 ; smartarg1 = static_cast< Teuchos::RCP< Tpetra::CrsMatrix >* >(farg1->cptr); arg1 = smartarg1 ? const_cast< Tpetra::CrsMatrix* >(smartarg1->get()) : NULL; - (&arg2)->first = static_cast(farg2->data); - (&arg2)->second = farg2->size; - (&arg3)->first = static_cast(farg3->data); - (&arg3)->second = farg3->size; - (&arg4)->first = static_cast(farg4->data); - (&arg4)->second = farg4->size; + tempbegin2 = static_cast(farg2->data); + arg2 = Teuchos::ArrayView(tempbegin2, farg2->size); + tempbegin3 = static_cast(farg3->data); + arg3 = Teuchos::ArrayView(tempbegin3, farg3->size); + tempbegin4 = static_cast(farg4->data); + arg4 = Teuchos::ArrayView(tempbegin4, farg4->size); { // Make sure no unhandled exceptions exist before performing a new action - SWIG_check_unhandled_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::setAllValues(std::pair< std::size_t *,std::size_t >,std::pair< LO *,std::size_t >,std::pair< SC *,std::size_t >)");; + SWIG_check_unhandled_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::setAllValues(Teuchos::ArrayView< std::size_t >,Teuchos::ArrayView< LO >,Teuchos::ArrayView< SC >)");; try { // Attempt the wrapped function call @@ -14038,16 +14066,16 @@ SWIGEXPORT void _wrap_TpetraCrsMatrix_setAllValues(SwigClassWrapper const *farg1 catch (const std::range_error& e) { // Store a C++ exception - SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::setAllValues(std::pair< std::size_t *,std::size_t >,std::pair< LO *,std::size_t >,std::pair< SC *,std::size_t >)", SWIG_IndexError, e.what(), return ); + SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::setAllValues(Teuchos::ArrayView< std::size_t >,Teuchos::ArrayView< LO >,Teuchos::ArrayView< SC >)", SWIG_IndexError, e.what(), return ); } catch (const std::exception& e) { // Store a C++ exception - SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::setAllValues(std::pair< std::size_t *,std::size_t >,std::pair< LO *,std::size_t >,std::pair< SC *,std::size_t >)", SWIG_RuntimeError, e.what(), return ); + SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::setAllValues(Teuchos::ArrayView< std::size_t >,Teuchos::ArrayView< LO >,Teuchos::ArrayView< SC >)", SWIG_RuntimeError, e.what(), return ); } catch (...) { - SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::setAllValues(std::pair< std::size_t *,std::size_t >,std::pair< LO *,std::size_t >,std::pair< SC *,std::size_t >)", SWIG_UnknownError, "An unknown exception occurred", return ); + SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::setAllValues(Teuchos::ArrayView< std::size_t >,Teuchos::ArrayView< LO >,Teuchos::ArrayView< SC >)", SWIG_UnknownError, "An unknown exception occurred", return ); } } @@ -14056,22 +14084,25 @@ SWIGEXPORT void _wrap_TpetraCrsMatrix_setAllValues(SwigClassWrapper const *farg1 SWIGEXPORT void _wrap_TpetraCrsMatrix_getAllValues(SwigClassWrapper const *farg1, SwigArrayWrapper *farg2, SwigArrayWrapper *farg3, SwigArrayWrapper *farg4) { Tpetra::CrsMatrix< SC,LO,GO,NO > *arg1 = (Tpetra::CrsMatrix< SC,LO,GO,NO > *) 0 ; - std::pair< std::size_t *,std::size_t > arg2 ; - std::pair< LO *,std::size_t > arg3 ; - std::pair< SC *,std::size_t > arg4 ; + Teuchos::ArrayView< std::size_t > arg2 ; + Teuchos::ArrayView< LO > arg3 ; + Teuchos::ArrayView< SC > arg4 ; Teuchos::RCP< Tpetra::CrsMatrix< SC,LO,GO,NO > const > *smartarg1 ; + unsigned long *tempbegin2 ; + int *tempbegin3 ; + double *tempbegin4 ; smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); arg1 = smartarg1 ? const_cast< Tpetra::CrsMatrix* >(smartarg1->get()) : NULL; - (&arg2)->first = static_cast(farg2->data); - (&arg2)->second = farg2->size; - (&arg3)->first = static_cast(farg3->data); - (&arg3)->second = farg3->size; - (&arg4)->first = static_cast(farg4->data); - (&arg4)->second = farg4->size; + tempbegin2 = static_cast(farg2->data); + arg2 = Teuchos::ArrayView(tempbegin2, farg2->size); + tempbegin3 = static_cast(farg3->data); + arg3 = Teuchos::ArrayView(tempbegin3, farg3->size); + tempbegin4 = static_cast(farg4->data); + arg4 = Teuchos::ArrayView(tempbegin4, farg4->size); { // Make sure no unhandled exceptions exist before performing a new action - SWIG_check_unhandled_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::getAllValues(std::pair< std::size_t *,std::size_t >,std::pair< LO *,std::size_t >,std::pair< SC *,std::size_t >) const");; + SWIG_check_unhandled_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::getAllValues(Teuchos::ArrayView< std::size_t >,Teuchos::ArrayView< LO >,Teuchos::ArrayView< SC >) const");; try { // Attempt the wrapped function call @@ -14080,59 +14111,16 @@ SWIGEXPORT void _wrap_TpetraCrsMatrix_getAllValues(SwigClassWrapper const *farg1 catch (const std::range_error& e) { // Store a C++ exception - SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::getAllValues(std::pair< std::size_t *,std::size_t >,std::pair< LO *,std::size_t >,std::pair< SC *,std::size_t >) const", SWIG_IndexError, e.what(), return ); - } - catch (const std::exception& e) - { - // Store a C++ exception - SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::getAllValues(std::pair< std::size_t *,std::size_t >,std::pair< LO *,std::size_t >,std::pair< SC *,std::size_t >) const", SWIG_RuntimeError, e.what(), return ); - } - catch (...) - { - SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::getAllValues(std::pair< std::size_t *,std::size_t >,std::pair< LO *,std::size_t >,std::pair< SC *,std::size_t >) const", SWIG_UnknownError, "An unknown exception occurred", return ); - } - } - -} - - -SWIGEXPORT void _wrap_TpetraCrsMatrix_getGlobalRowCopy(SwigClassWrapper const *farg1, long long const *farg2, SwigArrayWrapper *farg3, SwigArrayWrapper *farg4, size_t *farg5) { - Tpetra::CrsMatrix< SC,LO,GO,NO > *arg1 = (Tpetra::CrsMatrix< SC,LO,GO,NO > *) 0 ; - GO arg2 ; - std::pair< GO *,std::size_t > arg3 ; - std::pair< SC *,std::size_t > arg4 ; - size_t *arg5 = 0 ; - Teuchos::RCP< Tpetra::CrsMatrix< SC,LO,GO,NO > const > *smartarg1 ; - - smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); - arg1 = smartarg1 ? const_cast< Tpetra::CrsMatrix* >(smartarg1->get()) : NULL; - arg2 = static_cast< GO >(*farg2); - (&arg3)->first = static_cast(farg3->data); - (&arg3)->second = farg3->size; - (&arg4)->first = static_cast(farg4->data); - (&arg4)->second = farg4->size; - arg5 = reinterpret_cast< size_t * >(farg5); - { - // Make sure no unhandled exceptions exist before performing a new action - SWIG_check_unhandled_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::getGlobalRowCopy(GO,std::pair< GO *,std::size_t >,std::pair< SC *,std::size_t >,size_t &) const");; - try - { - // Attempt the wrapped function call - Tpetra_CrsMatrix_Sl_SC_Sc_LO_Sc_GO_Sc_NO_Sg__getGlobalRowCopy((Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const *)arg1,arg2,arg3,arg4,*arg5); - } - catch (const std::range_error& e) - { - // Store a C++ exception - SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::getGlobalRowCopy(GO,std::pair< GO *,std::size_t >,std::pair< SC *,std::size_t >,size_t &) const", SWIG_IndexError, e.what(), return ); + SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::getAllValues(Teuchos::ArrayView< std::size_t >,Teuchos::ArrayView< LO >,Teuchos::ArrayView< SC >) const", SWIG_IndexError, e.what(), return ); } catch (const std::exception& e) { // Store a C++ exception - SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::getGlobalRowCopy(GO,std::pair< GO *,std::size_t >,std::pair< SC *,std::size_t >,size_t &) const", SWIG_RuntimeError, e.what(), return ); + SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::getAllValues(Teuchos::ArrayView< std::size_t >,Teuchos::ArrayView< LO >,Teuchos::ArrayView< SC >) const", SWIG_RuntimeError, e.what(), return ); } catch (...) { - SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::getGlobalRowCopy(GO,std::pair< GO *,std::size_t >,std::pair< SC *,std::size_t >,size_t &) const", SWIG_UnknownError, "An unknown exception occurred", return ); + SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::getAllValues(Teuchos::ArrayView< std::size_t >,Teuchos::ArrayView< LO >,Teuchos::ArrayView< SC >) const", SWIG_UnknownError, "An unknown exception occurred", return ); } } @@ -14142,22 +14130,24 @@ SWIGEXPORT void _wrap_TpetraCrsMatrix_getGlobalRowCopy(SwigClassWrapper const *f SWIGEXPORT void _wrap_TpetraCrsMatrix_getLocalRowCopy(SwigClassWrapper const *farg1, int const *farg2, SwigArrayWrapper *farg3, SwigArrayWrapper *farg4, size_t *farg5) { Tpetra::CrsMatrix< SC,LO,GO,NO > *arg1 = (Tpetra::CrsMatrix< SC,LO,GO,NO > *) 0 ; LO arg2 ; - std::pair< LO *,std::size_t > arg3 ; - std::pair< SC *,std::size_t > arg4 ; + Teuchos::ArrayView< LO > arg3 ; + Teuchos::ArrayView< SC > arg4 ; size_t *arg5 = 0 ; Teuchos::RCP< Tpetra::CrsMatrix< SC,LO,GO,NO > const > *smartarg1 ; + int *tempbegin3 ; + double *tempbegin4 ; smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); arg1 = smartarg1 ? const_cast< Tpetra::CrsMatrix* >(smartarg1->get()) : NULL; arg2 = *farg2 - 1; - (&arg3)->first = static_cast(farg3->data); - (&arg3)->second = farg3->size; - (&arg4)->first = static_cast(farg4->data); - (&arg4)->second = farg4->size; + tempbegin3 = static_cast(farg3->data); + arg3 = Teuchos::ArrayView(tempbegin3, farg3->size); + tempbegin4 = static_cast(farg4->data); + arg4 = Teuchos::ArrayView(tempbegin4, farg4->size); arg5 = reinterpret_cast< size_t * >(farg5); { // Make sure no unhandled exceptions exist before performing a new action - SWIG_check_unhandled_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::getLocalRowCopy(LO,std::pair< LO *,std::size_t >,std::pair< SC *,std::size_t >,size_t &) const");; + SWIG_check_unhandled_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::getLocalRowCopy(LO,Teuchos::ArrayView< LO >,Teuchos::ArrayView< SC >,size_t &) const");; try { // Attempt the wrapped function call @@ -14166,93 +14156,16 @@ SWIGEXPORT void _wrap_TpetraCrsMatrix_getLocalRowCopy(SwigClassWrapper const *fa catch (const std::range_error& e) { // Store a C++ exception - SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::getLocalRowCopy(LO,std::pair< LO *,std::size_t >,std::pair< SC *,std::size_t >,size_t &) const", SWIG_IndexError, e.what(), return ); - } - catch (const std::exception& e) - { - // Store a C++ exception - SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::getLocalRowCopy(LO,std::pair< LO *,std::size_t >,std::pair< SC *,std::size_t >,size_t &) const", SWIG_RuntimeError, e.what(), return ); - } - catch (...) - { - SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::getLocalRowCopy(LO,std::pair< LO *,std::size_t >,std::pair< SC *,std::size_t >,size_t &) const", SWIG_UnknownError, "An unknown exception occurred", return ); - } - } - -} - - -SWIGEXPORT void _wrap_TpetraCrsMatrix_getGlobalRowView(SwigClassWrapper const *farg1, long long const *farg2, SwigArrayWrapper *farg3, SwigArrayWrapper *farg4) { - Tpetra::CrsMatrix< SC,LO,GO,NO > *arg1 = (Tpetra::CrsMatrix< SC,LO,GO,NO > *) 0 ; - GO arg2 ; - std::pair< GO const *,std::size_t > arg3 ; - std::pair< SC const *,std::size_t > arg4 ; - Teuchos::RCP< Tpetra::CrsMatrix< SC,LO,GO,NO > const > *smartarg1 ; - - smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); - arg1 = smartarg1 ? const_cast< Tpetra::CrsMatrix* >(smartarg1->get()) : NULL; - arg2 = static_cast< GO >(*farg2); - (&arg3)->first = static_cast(farg3->data); - (&arg3)->second = farg3->size; - (&arg4)->first = static_cast(farg4->data); - (&arg4)->second = farg4->size; - { - // Make sure no unhandled exceptions exist before performing a new action - SWIG_check_unhandled_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::getGlobalRowView(GO,std::pair< GO const *,std::size_t >,std::pair< SC const *,std::size_t >) const");; - try - { - // Attempt the wrapped function call - Tpetra_CrsMatrix_Sl_SC_Sc_LO_Sc_GO_Sc_NO_Sg__getGlobalRowView((Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const *)arg1,arg2,arg3,arg4); - } - catch (const std::range_error& e) - { - // Store a C++ exception - SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::getGlobalRowView(GO,std::pair< GO const *,std::size_t >,std::pair< SC const *,std::size_t >) const", SWIG_IndexError, e.what(), return ); - } - catch (const std::exception& e) - { - // Store a C++ exception - SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::getGlobalRowView(GO,std::pair< GO const *,std::size_t >,std::pair< SC const *,std::size_t >) const", SWIG_RuntimeError, e.what(), return ); - } - catch (...) - { - SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::getGlobalRowView(GO,std::pair< GO const *,std::size_t >,std::pair< SC const *,std::size_t >) const", SWIG_UnknownError, "An unknown exception occurred", return ); - } - } - -} - - -SWIGEXPORT void _wrap_TpetraCrsMatrix_getLocalDiagOffsets(SwigClassWrapper const *farg1, SwigArrayWrapper *farg2) { - Tpetra::CrsMatrix< SC,LO,GO,NO > *arg1 = (Tpetra::CrsMatrix< SC,LO,GO,NO > *) 0 ; - std::pair< std::size_t *,std::size_t > arg2 ; - Teuchos::RCP< Tpetra::CrsMatrix< SC,LO,GO,NO > const > *smartarg1 ; - - smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); - arg1 = smartarg1 ? const_cast< Tpetra::CrsMatrix* >(smartarg1->get()) : NULL; - (&arg2)->first = static_cast(farg2->data); - (&arg2)->second = farg2->size; - { - // Make sure no unhandled exceptions exist before performing a new action - SWIG_check_unhandled_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::getLocalDiagOffsets(std::pair< std::size_t *,std::size_t >) const");; - try - { - // Attempt the wrapped function call - Tpetra_CrsMatrix_Sl_SC_Sc_LO_Sc_GO_Sc_NO_Sg__getLocalDiagOffsets((Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const *)arg1,arg2); - } - catch (const std::range_error& e) - { - // Store a C++ exception - SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::getLocalDiagOffsets(std::pair< std::size_t *,std::size_t >) const", SWIG_IndexError, e.what(), return ); + SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::getLocalRowCopy(LO,Teuchos::ArrayView< LO >,Teuchos::ArrayView< SC >,size_t &) const", SWIG_IndexError, e.what(), return ); } catch (const std::exception& e) { // Store a C++ exception - SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::getLocalDiagOffsets(std::pair< std::size_t *,std::size_t >) const", SWIG_RuntimeError, e.what(), return ); + SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::getLocalRowCopy(LO,Teuchos::ArrayView< LO >,Teuchos::ArrayView< SC >,size_t &) const", SWIG_RuntimeError, e.what(), return ); } catch (...) { - SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::getLocalDiagOffsets(std::pair< std::size_t *,std::size_t >) const", SWIG_UnknownError, "An unknown exception occurred", return ); + SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::getLocalRowCopy(LO,Teuchos::ArrayView< LO >,Teuchos::ArrayView< SC >,size_t &) const", SWIG_UnknownError, "An unknown exception occurred", return ); } } diff --git a/src/tpetra/test/test_tpetra_import_export.F90 b/src/tpetra/test/test_tpetra_import_export.F90 index 93c46a99..da2623bb 100644 --- a/src/tpetra/test/test_tpetra_import_export.F90 +++ b/src/tpetra/test/test_tpetra_import_export.F90 @@ -113,16 +113,16 @@ program test_TpetraImportExport ! for tnum=1, these are contiguously allocated multivectors ! for tnum=2, these are non-contiguous views of multivectors if (tnum == 1) then - mv_mine = TpetraMultiVector(src, num_vecs) - mv_with_neighbors = TpetraMultiVector(tgt, num_vecs) + mv_mine = TpetraMultiVector(src, num_vecs); TEST_IERR() + mv_with_neighbors = TpetraMultiVector(tgt, num_vecs); TEST_IERR() else allocate(cols(5)) cols(:) = [1,7,4,5,6] - mine_parent = TpetraMultiVector(src, num_vecs+2) - neigh_parent = TpetraMultiVector(tgt, num_vecs+2) - TEST_ASSERT((num_vecs == 5)) - mv_mine = mine_parent%subViewNonConst(cols) - mv_with_neighbors = neigh_parent%subViewNonConst(cols) + mine_parent = TpetraMultiVector(src, num_vecs+2); TEST_IERR() + neigh_parent = TpetraMultiVector(tgt, num_vecs+2); TEST_IERR() + TEST_ASSERT((num_vecs == 5)); TEST_IERR() + mv_mine = mine_parent%subViewNonConst(cols); TEST_IERR() + mv_with_neighbors = neigh_parent%subViewNonConst(cols); TEST_IERR() end if ! mv_mine = [my_image_id my_image_id+num_images ... my_image_id+4*num_images] From eb2d742c2cee3f60923afae1d8ae3f73936fa3e0 Mon Sep 17 00:00:00 2001 From: Seth R Johnson Date: Sat, 2 Feb 2019 13:37:12 -0500 Subject: [PATCH 12/40] Improve typemap --- src/teuchos/src/Teuchos_ArrayView.i | 12 ++++------ .../src/swig/forteuchosFORTRAN_wrap.cxx | 24 +++++++------------ src/tpetra/src/fortpetra.i | 11 +++++++-- src/tpetra/test/test_tpetra_crsgraph.F90 | 15 ++++++------ 4 files changed, 31 insertions(+), 31 deletions(-) diff --git a/src/teuchos/src/Teuchos_ArrayView.i b/src/teuchos/src/Teuchos_ArrayView.i index 1fe6386c..4ff4d72f 100644 --- a/src/teuchos/src/Teuchos_ArrayView.i +++ b/src/teuchos/src/Teuchos_ArrayView.i @@ -22,15 +22,13 @@ class ArrayView // Add native wrapping typemaps to convert to/from Teuchos array %fortran_array_pointer(_Tp, ArrayView<_Tp>) - %typemap(in, noblock=1) ArrayView<_Tp> (_Tp* tempbegin) { - tempbegin = static_cast<_Tp*>($input->data); - $1 = Teuchos::ArrayView<_Tp>(tempbegin, $input->size); + %typemap(in, noblock=1) ArrayView<_Tp> { + $1 = Teuchos::ArrayView<_Tp>(static_cast<_Tp*>($input->data), $input->size); } - %typemap(in, noblock=1) const ArrayView<_Tp> & (_Tp* tempbegin, Teuchos::ArrayView<_Tp> temparr) { - tempbegin = static_cast<_Tp*>($input->data); - temparr = Teuchos::ArrayView<_Tp>(tempbegin, $input->size); - $1 = &temparr; + %typemap(in, noblock=1) const ArrayView<_Tp> & (Teuchos::ArrayView<_Tp> tmparr) { + tmparr = Teuchos::ArrayView<_Tp>(static_cast<_Tp*>($input->data), $input->size); + $1 = &tmparr; } %typemap(out, noblock=1) ArrayView<_Tp> { diff --git a/src/teuchos/src/swig/forteuchosFORTRAN_wrap.cxx b/src/teuchos/src/swig/forteuchosFORTRAN_wrap.cxx index dca4ad89..add0907e 100644 --- a/src/teuchos/src/swig/forteuchosFORTRAN_wrap.cxx +++ b/src/teuchos/src/swig/forteuchosFORTRAN_wrap.cxx @@ -656,13 +656,11 @@ extern "C" { SWIGEXPORT SwigClassWrapper _wrap_new_TeuchosArrayInt(SwigArrayWrapper *farg1) { SwigClassWrapper fresult ; Teuchos::ArrayView< int const > *arg1 = 0 ; - int const *tempbegin1 ; - Teuchos::ArrayView< int const > temparr1 ; + Teuchos::ArrayView< int const > tmparr1 ; Teuchos::Array< int > *result = 0 ; - tempbegin1 = static_cast(farg1->data); - temparr1 = Teuchos::ArrayView(tempbegin1, farg1->size); - arg1 = &temparr1; + tmparr1 = Teuchos::ArrayView(static_cast(farg1->data), farg1->size); + arg1 = &tmparr1; { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Teuchos::Array< int >::Array(Teuchos::ArrayView< int const > const &)");; @@ -771,13 +769,11 @@ SWIGEXPORT void _wrap_assign_TeuchosArrayInt(SwigClassWrapper * self, SwigClassW SWIGEXPORT SwigClassWrapper _wrap_new_TeuchosArrayDbl(SwigArrayWrapper *farg1) { SwigClassWrapper fresult ; Teuchos::ArrayView< double const > *arg1 = 0 ; - double const *tempbegin1 ; - Teuchos::ArrayView< double const > temparr1 ; + Teuchos::ArrayView< double const > tmparr1 ; Teuchos::Array< double > *result = 0 ; - tempbegin1 = static_cast(farg1->data); - temparr1 = Teuchos::ArrayView(tempbegin1, farg1->size); - arg1 = &temparr1; + tmparr1 = Teuchos::ArrayView(static_cast(farg1->data), farg1->size); + arg1 = &tmparr1; { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Teuchos::Array< double >::Array(Teuchos::ArrayView< double const > const &)");; @@ -886,13 +882,11 @@ SWIGEXPORT void _wrap_assign_TeuchosArrayDbl(SwigClassWrapper * self, SwigClassW SWIGEXPORT SwigClassWrapper _wrap_new_TeuchosArrayLongLong(SwigArrayWrapper *farg1) { SwigClassWrapper fresult ; Teuchos::ArrayView< long long const > *arg1 = 0 ; - long long const *tempbegin1 ; - Teuchos::ArrayView< long long const > temparr1 ; + Teuchos::ArrayView< long long const > tmparr1 ; Teuchos::Array< long long > *result = 0 ; - tempbegin1 = static_cast(farg1->data); - temparr1 = Teuchos::ArrayView(tempbegin1, farg1->size); - arg1 = &temparr1; + tmparr1 = Teuchos::ArrayView(static_cast(farg1->data), farg1->size); + arg1 = &tmparr1; { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Teuchos::Array< long long >::Array(Teuchos::ArrayView< long long const > const &)");; diff --git a/src/tpetra/src/fortpetra.i b/src/tpetra/src/fortpetra.i index d745b05d..d1d85893 100644 --- a/src/tpetra/src/fortpetra.i +++ b/src/tpetra/src/fortpetra.i @@ -67,6 +67,7 @@ public :: norm_type #include %} +// *Input* fortran indices %typemap(in, fragment="", noblock=1) const Teuchos::ArrayView& INDEX ($1_basetype::value_type* tmpbegin, Teuchos::Array::type> tmparr, @@ -77,11 +78,17 @@ public :: norm_type for (int i = 0; i < tmparr.size(); i++) tmparr[i] = tmpbegin[i] - 1; tmpview = tmparr(); - - // Make the input argument point to our temporary vector $1 = &tmpview; } +// *Return* by reference fortran indices. This modifies the return values after +// calling the wrapped C++ function. +%typemap(freearg, noblock=1) const Teuchos::ArrayView& INDEX +{ + for (int i = 0; i < tmparr$argnum.size(); i++) + tmparr$argnum[i] += 1; +} + // All enums should be prefaced with Tpetra %rename("Tpetra%s", %$isenumitem) ""; %rename("Tpetra%s", %$isenum) ""; diff --git a/src/tpetra/test/test_tpetra_crsgraph.F90 b/src/tpetra/test/test_tpetra_crsgraph.F90 index 7c5e8aad..725153dc 100644 --- a/src/tpetra/test/test_tpetra_crsgraph.F90 +++ b/src/tpetra/test/test_tpetra_crsgraph.F90 @@ -321,7 +321,7 @@ program test_TpetraCrsGraph map = TpetraMap(TPETRA_GLOBAL_INVALID, num_local, comm) nument = 4 - Graph = TpetraCrsGraph(map, map, nument); + Graph = TpetraCrsGraph(map, map, nument); TEST_IERR() TEST_ASSERT(graph%isSorted()) ! insert entries; shouldn't be sorted anymore @@ -339,7 +339,7 @@ program test_TpetraCrsGraph if (map%isNodeGlobalElement(lastind)) then jinds(jj) = lastind; jj = jj + 1 end if - call Graph%insertGlobalIndices(j, jinds(1:jj-1)) + call Graph%insertGlobalIndices(j, jinds(1:jj-1)); TEST_IERR() end do TEST_ASSERT((.not. Graph%isSorted())) deallocate(jinds) @@ -355,7 +355,8 @@ program test_TpetraCrsGraph do k = kstart, kfinish nument = Graph%getNumEntriesInLocalRow(k) allocate(kinds(nument)) - call Graph%getLocalRowCopy(k, kinds, nument); + write (*,*) "Allocated", nument, "for k=", k + call Graph%getLocalRowCopy(k, kinds, nument); TEST_IERR() do kk = 2, nument if (kinds(kk-1) > kinds(kk)) then sorting_check = .false. @@ -367,7 +368,7 @@ program test_TpetraCrsGraph end do ! resume fill; should still be sorted - call Graph%resumeFill() + call Graph%resumeFill(); TEST_IERR() TEST_ASSERT(graph%isSorted()) sorting_check = .true. @@ -376,7 +377,7 @@ program test_TpetraCrsGraph do k = kstart, kfinish nument = Graph%getNumEntriesInLocalRow(k) allocate(kinds(nument)) - call Graph%getLocalRowCopy(k, kinds, nument); + call Graph%getLocalRowCopy(k, kinds, nument); TEST_IERR() do kk = 2, nument if (kinds(kk-1) > kinds(kk)) then sorting_check = .false. @@ -392,7 +393,7 @@ program test_TpetraCrsGraph k = 1 allocate(kinds(1)) kinds(1) = 1 - call Graph%insertLocalIndices(k, kinds) + call Graph%insertLocalIndices(k, kinds); TEST_IERR() TEST_ASSERT((.not. graph%isSorted())) deallocate(kinds) @@ -406,7 +407,7 @@ program test_TpetraCrsGraph do k = kstart, kfinish nument = Graph%getNumEntriesInLocalRow(k) allocate(kinds(nument)) - call Graph%getLocalRowCopy(k, kinds, nument); + call Graph%getLocalRowCopy(k, kinds, nument); TEST_IERR() do kk = 2, nument if (kinds(kk-1) > kinds(kk)) then sorting_check = .false. From 456e45ed45aa5244018ff4ab16920d8b3a82cc99 Mon Sep 17 00:00:00 2001 From: Seth R Johnson Date: Sat, 2 Feb 2019 13:43:12 -0500 Subject: [PATCH 13/40] Improve CRS typemaps --- src/tpetra/src/Tpetra_CrsGraph.i | 23 +- src/tpetra/src/swig/fortpetra.F90 | 200 +++--- src/tpetra/src/swig/fortpetraFORTRAN_wrap.cxx | 588 +++++++----------- 3 files changed, 333 insertions(+), 478 deletions(-) diff --git a/src/tpetra/src/Tpetra_CrsGraph.i b/src/tpetra/src/Tpetra_CrsGraph.i index c23e1a0c..9f0ad38e 100644 --- a/src/tpetra/src/Tpetra_CrsGraph.i +++ b/src/tpetra/src/Tpetra_CrsGraph.i @@ -68,7 +68,11 @@ // ======================================================================= // Fix ±1 issues // ======================================================================= -%apply int INDEX { int localRow }; +%apply int INDEX { int localRow, int LocalRow }; + +%apply const Teuchos::ArrayView& INDEX { const Teuchos::ArrayView& indices } + +%apply const Teuchos::ArrayView& INDEX { const Teuchos::ArrayView& indices } %apply int { size_t getNumEntriesInLocalRow, size_t getNumAllocatedEntriesInLocalRow} @@ -104,20 +108,6 @@ return new Tpetra::CrsGraph(rowMap, colMap, Teuchos::arcpFromArray(rowPointersArray), Teuchos::arcpFromArray(columnIndicesArray), params); } - void insertGlobalIndices(const GO globalRow, Teuchos::ArrayView indicesView) { - $self->insertGlobalIndices(globalRow, indicesView); - } - void insertLocalIndices(const LO localRow, Teuchos::ArrayView indices) { - Teuchos::Array indicesArray(indices.size()); - for (size_t i = 0; i < indicesArray.size(); i++) - indicesArray[i] = indices[i]-1; - $self->insertLocalIndices(localRow, indicesArray); - } - void getLocalRowCopy(LO localRow, Teuchos::ArrayView indicesView, size_t &NumIndices) const { - $self->getLocalRowCopy(localRow, indicesView, NumIndices); - for (int i = 0; i < indicesView.size(); i++) - indicesView[i]++; - } void setAllIndices(Teuchos::ArrayView rowPointers, Teuchos::ArrayView columnIndices, Teuchos::ArrayView val) { Teuchos::ArrayRCP rowPointersArrayRCP(rowPointers.size()); for (int i = 0; i < rowPointersArrayRCP.size(); i++) @@ -168,9 +158,6 @@ const Teuchos::ArrayRCP< size_t > &rowPointers, const Teuchos::ArrayRCP< LocalOrdinal > &columnIndices, const Teuchos::RCP< Teuchos::ParameterList > ¶ms=Teuchos::null); // needs Teuchos::ArrayRCP; ±1 issue -%ignore Tpetra::CrsGraph::insertGlobalIndices (const GlobalOrdinal globalRow, const Teuchos::ArrayView< const GlobalOrdinal > &indices); -%ignore Tpetra::CrsGraph::insertLocalIndices(const LocalOrdinal localRow, const Teuchos::ArrayView< const LocalOrdinal > &indices); -%ignore Tpetra::CrsGraph::getLocalRowCopy(LocalOrdinal LocalRow, const Teuchos::ArrayView< LocalOrdinal > &indices, size_t &NumIndices) const; %ignore Tpetra::CrsGraph::getNodeRowPtrs() const; %ignore Tpetra::CrsGraph::getNodePackedIndices() const; %ignore Tpetra::CrsGraph::getLocalDiagOffsets; diff --git a/src/tpetra/src/swig/fortpetra.F90 b/src/tpetra/src/swig/fortpetra.F90 index 04b10164..08780340 100644 --- a/src/tpetra/src/swig/fortpetra.F90 +++ b/src/tpetra/src/swig/fortpetra.F90 @@ -372,6 +372,8 @@ module fortpetra procedure :: setParameterList => swigf_TpetraCrsGraph_setParameterList procedure :: getValidParameters => swigf_TpetraCrsGraph_getValidParameters procedure, private :: insertGlobalIndices__SWIG_0 => swigf_TpetraCrsGraph_insertGlobalIndices__SWIG_0 + procedure, private :: insertGlobalIndices__SWIG_1 => swigf_TpetraCrsGraph_insertGlobalIndices__SWIG_1 + procedure :: insertLocalIndices => swigf_TpetraCrsGraph_insertLocalIndices procedure :: removeLocalIndices => swigf_TpetraCrsGraph_removeLocalIndices procedure :: globalAssemble => swigf_TpetraCrsGraph_globalAssemble procedure, private :: resumeFill__SWIG_0 => swigf_TpetraCrsGraph_resumeFill__SWIG_0 @@ -417,6 +419,7 @@ module fortpetra procedure :: isStorageOptimized => swigf_TpetraCrsGraph_isStorageOptimized procedure :: getProfileType => swigf_TpetraCrsGraph_getProfileType procedure :: getGlobalRowCopy => swigf_TpetraCrsGraph_getGlobalRowCopy + procedure :: getLocalRowCopy => swigf_TpetraCrsGraph_getLocalRowCopy procedure :: supportsRowViews => swigf_TpetraCrsGraph_supportsRowViews procedure :: description => swigf_TpetraCrsGraph_description procedure :: replaceColMap => swigf_TpetraCrsGraph_replaceColMap @@ -435,9 +438,6 @@ module fortpetra procedure, private :: exportAndFillComplete__SWIG_4 => swigf_TpetraCrsGraph_exportAndFillComplete__SWIG_4 procedure :: haveGlobalConstants => swigf_TpetraCrsGraph_haveGlobalConstants procedure :: computeGlobalConstants => swigf_TpetraCrsGraph_computeGlobalConstants - procedure, private :: insertGlobalIndices__SWIG_1 => swigf_TpetraCrsGraph_insertGlobalIndices__SWIG_1 - procedure :: insertLocalIndices => swigf_TpetraCrsGraph_insertLocalIndices - procedure :: getLocalRowCopy => swigf_TpetraCrsGraph_getLocalRowCopy procedure :: setAllIndices => swigf_TpetraCrsGraph_setAllIndices procedure :: getNodeRowPtrs => swigf_TpetraCrsGraph_getNodeRowPtrs procedure :: getNodePackedIndices => swigf_TpetraCrsGraph_getNodePackedIndices @@ -2248,16 +2248,36 @@ function swigc_TpetraCrsGraph_getValidParameters(farg1) & type(SwigClassWrapper) :: fresult end function -subroutine swigc_TpetraCrsGraph_insertGlobalIndices__SWIG_0(farg1, farg2, farg3, farg4) & +subroutine swigc_TpetraCrsGraph_insertGlobalIndices__SWIG_0(farg1, farg2, farg3) & bind(C, name="_wrap_TpetraCrsGraph_insertGlobalIndices__SWIG_0") use, intrinsic :: ISO_C_BINDING import :: swigclasswrapper +import :: swigarraywrapper +type(SwigClassWrapper) :: farg1 +integer(C_LONG_LONG), intent(in) :: farg2 +type(SwigArrayWrapper) :: farg3 +end subroutine + +subroutine swigc_TpetraCrsGraph_insertGlobalIndices__SWIG_1(farg1, farg2, farg3, farg4) & +bind(C, name="_wrap_TpetraCrsGraph_insertGlobalIndices__SWIG_1") +use, intrinsic :: ISO_C_BINDING +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 integer(C_LONG_LONG), intent(in) :: farg2 integer(C_INT), intent(in) :: farg3 type(C_PTR), value :: farg4 end subroutine +subroutine swigc_TpetraCrsGraph_insertLocalIndices(farg1, farg2, farg3) & +bind(C, name="_wrap_TpetraCrsGraph_insertLocalIndices") +use, intrinsic :: ISO_C_BINDING +import :: swigclasswrapper +import :: swigarraywrapper +type(SwigClassWrapper) :: farg1 +integer(C_INT), intent(in) :: farg2 +type(SwigArrayWrapper) :: farg3 +end subroutine + subroutine swigc_TpetraCrsGraph_removeLocalIndices(farg1, farg2) & bind(C, name="_wrap_TpetraCrsGraph_removeLocalIndices") use, intrinsic :: ISO_C_BINDING @@ -2667,6 +2687,17 @@ subroutine swigc_TpetraCrsGraph_getGlobalRowCopy(farg1, farg2, farg3, farg4) & type(C_PTR), value :: farg4 end subroutine +subroutine swigc_TpetraCrsGraph_getLocalRowCopy(farg1, farg2, farg3, farg4) & +bind(C, name="_wrap_TpetraCrsGraph_getLocalRowCopy") +use, intrinsic :: ISO_C_BINDING +import :: swigclasswrapper +import :: swigarraywrapper +type(SwigClassWrapper) :: farg1 +integer(C_INT), intent(in) :: farg2 +type(SwigArrayWrapper) :: farg3 +type(C_PTR), value :: farg4 +end subroutine + function swigc_TpetraCrsGraph_supportsRowViews(farg1) & bind(C, name="_wrap_TpetraCrsGraph_supportsRowViews") & result(fresult) @@ -2948,37 +2979,6 @@ function swigc_new_TpetraCrsGraph__SWIG_13(farg1, farg2, farg3, farg4) & type(SwigClassWrapper) :: fresult end function -subroutine swigc_TpetraCrsGraph_insertGlobalIndices__SWIG_1(farg1, farg2, farg3) & -bind(C, name="_wrap_TpetraCrsGraph_insertGlobalIndices__SWIG_1") -use, intrinsic :: ISO_C_BINDING -import :: swigclasswrapper -import :: swigarraywrapper -type(SwigClassWrapper) :: farg1 -integer(C_LONG_LONG), intent(in) :: farg2 -type(SwigArrayWrapper) :: farg3 -end subroutine - -subroutine swigc_TpetraCrsGraph_insertLocalIndices(farg1, farg2, farg3) & -bind(C, name="_wrap_TpetraCrsGraph_insertLocalIndices") -use, intrinsic :: ISO_C_BINDING -import :: swigclasswrapper -import :: swigarraywrapper -type(SwigClassWrapper) :: farg1 -integer(C_INT), intent(in) :: farg2 -type(SwigArrayWrapper) :: farg3 -end subroutine - -subroutine swigc_TpetraCrsGraph_getLocalRowCopy(farg1, farg2, farg3, farg4) & -bind(C, name="_wrap_TpetraCrsGraph_getLocalRowCopy") -use, intrinsic :: ISO_C_BINDING -import :: swigclasswrapper -import :: swigarraywrapper -type(SwigClassWrapper) :: farg1 -integer(C_INT), intent(in) :: farg2 -type(SwigArrayWrapper) :: farg3 -type(C_PTR), value :: farg4 -end subroutine - subroutine swigc_TpetraCrsGraph_setAllIndices(farg1, farg2, farg3, farg4) & bind(C, name="_wrap_TpetraCrsGraph_setAllIndices") use, intrinsic :: ISO_C_BINDING @@ -7575,7 +7575,27 @@ function swigf_TpetraCrsGraph_getValidParameters(self) & swig_result%swigdata = fresult end function -subroutine swigf_TpetraCrsGraph_insertGlobalIndices__SWIG_0(self, globalrow, nument, inds) +subroutine swigf_TpetraCrsGraph_insertGlobalIndices__SWIG_0(self, globalrow, indices) +use, intrinsic :: ISO_C_BINDING +class(TpetraCrsGraph), intent(inout) :: self + +integer(C_LONG_LONG), intent(in) :: globalrow +integer(C_LONG_LONG), dimension(:), target :: indices +integer(C_LONG_LONG), pointer :: farg3_view + +type(SwigClassWrapper) :: farg1 +integer(C_LONG_LONG) :: farg2 +type(SwigArrayWrapper) :: farg3 + +farg1 = self%swigdata +farg2 = globalrow +farg3_view => indices(1) +farg3%data = c_loc(farg3_view) +farg3%size = size(indices) +call swigc_TpetraCrsGraph_insertGlobalIndices__SWIG_0(farg1, farg2, farg3) +end subroutine + +subroutine swigf_TpetraCrsGraph_insertGlobalIndices__SWIG_1(self, globalrow, nument, inds) use, intrinsic :: ISO_C_BINDING class(TpetraCrsGraph), intent(inout) :: self @@ -7592,7 +7612,27 @@ subroutine swigf_TpetraCrsGraph_insertGlobalIndices__SWIG_0(self, globalrow, num farg2 = globalrow farg3 = int(nument, C_INT) farg4 = c_loc(inds(1)) -call swigc_TpetraCrsGraph_insertGlobalIndices__SWIG_0(farg1, farg2, farg3, farg4) +call swigc_TpetraCrsGraph_insertGlobalIndices__SWIG_1(farg1, farg2, farg3, farg4) +end subroutine + +subroutine swigf_TpetraCrsGraph_insertLocalIndices(self, localrow, indices) +use, intrinsic :: ISO_C_BINDING +class(TpetraCrsGraph), intent(inout) :: self + +integer, intent(in) :: localrow +integer(C_INT), dimension(:), target :: indices +integer(C_INT), pointer :: farg3_view + +type(SwigClassWrapper) :: farg1 +integer(C_INT) :: farg2 +type(SwigArrayWrapper) :: farg3 + +farg1 = self%swigdata +farg2 = int(localrow, C_INT) +farg3_view => indices(1) +farg3%data = c_loc(farg3_view) +farg3%size = size(indices) +call swigc_TpetraCrsGraph_insertLocalIndices(farg1, farg2, farg3) end subroutine subroutine swigf_TpetraCrsGraph_removeLocalIndices(self, localrow) @@ -8290,6 +8330,29 @@ subroutine swigf_TpetraCrsGraph_getGlobalRowCopy(self, globalrow, indices, numin call swigc_TpetraCrsGraph_getGlobalRowCopy(farg1, farg2, farg3, farg4) end subroutine +subroutine swigf_TpetraCrsGraph_getLocalRowCopy(self, localrow, indices, numindices) +use, intrinsic :: ISO_C_BINDING +class(TpetraCrsGraph), intent(in) :: self + +integer, intent(in) :: localrow +integer(C_INT), dimension(:), target :: indices +integer(C_INT), pointer :: farg3_view +integer(C_SIZE_T), target, intent(inout) :: numindices + +type(SwigClassWrapper) :: farg1 +integer(C_INT) :: farg2 +type(SwigArrayWrapper) :: farg3 +type(C_PTR) :: farg4 + +farg1 = self%swigdata +farg2 = int(localrow, C_INT) +farg3_view => indices(1) +farg3%data = c_loc(farg3_view) +farg3%size = size(indices) +farg4 = c_loc(numindices) +call swigc_TpetraCrsGraph_getLocalRowCopy(farg1, farg2, farg3, farg4) +end subroutine + function swigf_TpetraCrsGraph_supportsRowViews(self) & result(swig_result) use, intrinsic :: ISO_C_BINDING @@ -8890,69 +8953,6 @@ function new_TpetraCrsGraph__SWIG_13(rowmap, colmap, rowpointers, columnindices) self%swigdata = fresult end function -subroutine swigf_TpetraCrsGraph_insertGlobalIndices__SWIG_1(self, globalrow, indicesview) -use, intrinsic :: ISO_C_BINDING -class(TpetraCrsGraph), intent(inout) :: self - -integer(C_LONG_LONG), intent(in) :: globalrow -integer(C_LONG_LONG), dimension(:), target :: indicesview -integer(C_LONG_LONG), pointer :: farg3_view - -type(SwigClassWrapper) :: farg1 -integer(C_LONG_LONG) :: farg2 -type(SwigArrayWrapper) :: farg3 - -farg1 = self%swigdata -farg2 = globalrow -farg3_view => indicesview(1) -farg3%data = c_loc(farg3_view) -farg3%size = size(indicesview) -call swigc_TpetraCrsGraph_insertGlobalIndices__SWIG_1(farg1, farg2, farg3) -end subroutine - -subroutine swigf_TpetraCrsGraph_insertLocalIndices(self, localrow, indices) -use, intrinsic :: ISO_C_BINDING -class(TpetraCrsGraph), intent(inout) :: self - -integer, intent(in) :: localrow -integer(C_INT), dimension(:), target :: indices -integer(C_INT), pointer :: farg3_view - -type(SwigClassWrapper) :: farg1 -integer(C_INT) :: farg2 -type(SwigArrayWrapper) :: farg3 - -farg1 = self%swigdata -farg2 = int(localrow, C_INT) -farg3_view => indices(1) -farg3%data = c_loc(farg3_view) -farg3%size = size(indices) -call swigc_TpetraCrsGraph_insertLocalIndices(farg1, farg2, farg3) -end subroutine - -subroutine swigf_TpetraCrsGraph_getLocalRowCopy(self, localrow, indicesview, numindices) -use, intrinsic :: ISO_C_BINDING -class(TpetraCrsGraph), intent(in) :: self - -integer, intent(in) :: localrow -integer(C_INT), dimension(:), target :: indicesview -integer(C_INT), pointer :: farg3_view -integer(C_SIZE_T), target, intent(inout) :: numindices - -type(SwigClassWrapper) :: farg1 -integer(C_INT) :: farg2 -type(SwigArrayWrapper) :: farg3 -type(C_PTR) :: farg4 - -farg1 = self%swigdata -farg2 = int(localrow, C_INT) -farg3_view => indicesview(1) -farg3%data = c_loc(farg3_view) -farg3%size = size(indicesview) -farg4 = c_loc(numindices) -call swigc_TpetraCrsGraph_getLocalRowCopy(farg1, farg2, farg3, farg4) -end subroutine - subroutine swigf_TpetraCrsGraph_setAllIndices(self, rowpointers, columnindices, val) use, intrinsic :: ISO_C_BINDING class(TpetraCrsGraph), intent(inout) :: self diff --git a/src/tpetra/src/swig/fortpetraFORTRAN_wrap.cxx b/src/tpetra/src/swig/fortpetraFORTRAN_wrap.cxx index fbc21bcc..2e255aa5 100644 --- a/src/tpetra/src/swig/fortpetraFORTRAN_wrap.cxx +++ b/src/tpetra/src/swig/fortpetraFORTRAN_wrap.cxx @@ -734,20 +734,6 @@ SWIGINTERN Tpetra::CrsGraph< LO,GO,NO > *new_Tpetra_CrsGraph_Sl_LO_Sc_GO_Sc_NO_S return new Tpetra::CrsGraph(rowMap, colMap, Teuchos::arcpFromArray(rowPointersArray), Teuchos::arcpFromArray(columnIndicesArray), params); } -SWIGINTERN void Tpetra_CrsGraph_Sl_LO_Sc_GO_Sc_NO_Sg__insertGlobalIndices__SWIG_1(Tpetra::CrsGraph< LO,GO,NO > *self,GO const globalRow,Teuchos::ArrayView< GO const > indicesView){ - self->insertGlobalIndices(globalRow, indicesView); - } -SWIGINTERN void Tpetra_CrsGraph_Sl_LO_Sc_GO_Sc_NO_Sg__insertLocalIndices(Tpetra::CrsGraph< LO,GO,NO > *self,LO const localRow,Teuchos::ArrayView< LO const > indices){ - Teuchos::Array indicesArray(indices.size()); - for (size_t i = 0; i < indicesArray.size(); i++) - indicesArray[i] = indices[i]-1; - self->insertLocalIndices(localRow, indicesArray); - } -SWIGINTERN void Tpetra_CrsGraph_Sl_LO_Sc_GO_Sc_NO_Sg__getLocalRowCopy(Tpetra::CrsGraph< LO,GO,NO > const *self,LO localRow,Teuchos::ArrayView< LO > indicesView,size_t &NumIndices){ - self->getLocalRowCopy(localRow, indicesView, NumIndices); - for (int i = 0; i < indicesView.size(); i++) - indicesView[i]++; - } SWIGINTERN void Tpetra_CrsGraph_Sl_LO_Sc_GO_Sc_NO_Sg__setAllIndices(Tpetra::CrsGraph< LO,GO,NO > *self,Teuchos::ArrayView< std::size_t > rowPointers,Teuchos::ArrayView< LO > columnIndices,Teuchos::ArrayView< SC > val){ Teuchos::ArrayRCP rowPointersArrayRCP(rowPointers.size()); for (int i = 0; i < rowPointersArrayRCP.size(); i++) @@ -1493,25 +1479,19 @@ SWIGEXPORT int _wrap_TpetraMap_getRemoteIndexList__SWIG_0(SwigClassWrapper const Teuchos::ArrayView< int > *arg3 = 0 ; Teuchos::ArrayView< int > *arg4 = 0 ; Teuchos::RCP< Tpetra::Map< LO,GO,NO > const > *smartarg1 ; - long long const *tempbegin2 ; - Teuchos::ArrayView< long long const > temparr2 ; - int *tempbegin3 ; - Teuchos::ArrayView< int > temparr3 ; - int *tempbegin4 ; - Teuchos::ArrayView< int > temparr4 ; + Teuchos::ArrayView< long long const > tmparr2 ; + Teuchos::ArrayView< int > tmparr3 ; + Teuchos::ArrayView< int > tmparr4 ; Tpetra::LookupStatus result; smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); arg1 = smartarg1 ? const_cast< Tpetra::Map* >(smartarg1->get()) : NULL; - tempbegin2 = static_cast(farg2->data); - temparr2 = Teuchos::ArrayView(tempbegin2, farg2->size); - arg2 = &temparr2; - tempbegin3 = static_cast(farg3->data); - temparr3 = Teuchos::ArrayView(tempbegin3, farg3->size); - arg3 = &temparr3; - tempbegin4 = static_cast(farg4->data); - temparr4 = Teuchos::ArrayView(tempbegin4, farg4->size); - arg4 = &temparr4; + tmparr2 = Teuchos::ArrayView(static_cast(farg2->data), farg2->size); + arg2 = &tmparr2; + tmparr3 = Teuchos::ArrayView(static_cast(farg3->data), farg3->size); + arg3 = &tmparr3; + tmparr4 = Teuchos::ArrayView(static_cast(farg4->data), farg4->size); + arg4 = &tmparr4; { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::Map< LO,GO,NO >::getRemoteIndexList(Teuchos::ArrayView< long long const > const &,Teuchos::ArrayView< int > const &,Teuchos::ArrayView< int > const &) const");; @@ -1554,20 +1534,16 @@ SWIGEXPORT int _wrap_TpetraMap_getRemoteIndexList__SWIG_1(SwigClassWrapper const Teuchos::ArrayView< long long const > *arg2 = 0 ; Teuchos::ArrayView< int > *arg3 = 0 ; Teuchos::RCP< Tpetra::Map< LO,GO,NO > const > *smartarg1 ; - long long const *tempbegin2 ; - Teuchos::ArrayView< long long const > temparr2 ; - int *tempbegin3 ; - Teuchos::ArrayView< int > temparr3 ; + Teuchos::ArrayView< long long const > tmparr2 ; + Teuchos::ArrayView< int > tmparr3 ; Tpetra::LookupStatus result; smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); arg1 = smartarg1 ? const_cast< Tpetra::Map* >(smartarg1->get()) : NULL; - tempbegin2 = static_cast(farg2->data); - temparr2 = Teuchos::ArrayView(tempbegin2, farg2->size); - arg2 = &temparr2; - tempbegin3 = static_cast(farg3->data); - temparr3 = Teuchos::ArrayView(tempbegin3, farg3->size); - arg3 = &temparr3; + tmparr2 = Teuchos::ArrayView(static_cast(farg2->data), farg2->size); + arg2 = &tmparr2; + tmparr3 = Teuchos::ArrayView(static_cast(farg3->data), farg3->size); + arg3 = &tmparr3; { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::Map< LO,GO,NO >::getRemoteIndexList(Teuchos::ArrayView< long long const > const &,Teuchos::ArrayView< int > const &) const");; @@ -2264,13 +2240,11 @@ SWIGEXPORT SwigClassWrapper _wrap_new_TpetraMap__SWIG_4(long const *farg1, SwigA Tpetra::global_size_t arg1 ; Teuchos::ArrayView< GO const > arg2 ; Teuchos::RCP< Teuchos::Comm< int > const > *arg3 = 0 ; - long long const *tempbegin2 ; Teuchos::RCP< Teuchos::Comm< int > const > tempnull3 ; Tpetra::Map< LO,GO,NO > *result = 0 ; arg1 = static_cast< Tpetra::global_size_t >(*farg1); - tempbegin2 = static_cast(farg2->data); - arg2 = Teuchos::ArrayView(tempbegin2, farg2->size); + arg2 = Teuchos::ArrayView(static_cast(farg2->data), farg2->size); arg3 = farg3->cptr ? static_cast< Teuchos::RCP< Teuchos::Comm< int > const > * >(farg3->cptr) : &tempnull3; { // Make sure no unhandled exceptions exist before performing a new action @@ -3598,14 +3572,12 @@ SWIGEXPORT SwigClassWrapper _wrap_new_TpetraMultiVector__SWIG_5(SwigClassWrapper size_t arg3 ; size_t arg4 ; Teuchos::RCP< Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > tempnull1 ; - double const *tempbegin2 ; - Teuchos::ArrayView< double const > temparr2 ; + Teuchos::ArrayView< double const > tmparr2 ; Tpetra::MultiVector< SC,LO,GO,NO > *result = 0 ; arg1 = farg1->cptr ? static_cast< Teuchos::RCP< Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg1->cptr) : &tempnull1; - tempbegin2 = static_cast(farg2->data); - temparr2 = Teuchos::ArrayView(tempbegin2, farg2->size); - arg2 = &temparr2; + tmparr2 = Teuchos::ArrayView(static_cast(farg2->data), farg2->size); + arg2 = &tmparr2; arg3 = static_cast< size_t >(*farg3); arg4 = static_cast< size_t >(*farg4); { @@ -4243,8 +4215,6 @@ SWIGEXPORT SwigClassWrapper _wrap_TpetraMultiVector_subCopy(SwigClassWrapper con for (int i = 0; i < tmparr2.size(); i++) tmparr2[i] = tmpbegin2[i] - 1; tmpview2 = tmparr2(); - - // Make the input argument point to our temporary vector arg2 = &tmpview2; { // Make sure no unhandled exceptions exist before performing a new action @@ -4292,8 +4262,6 @@ SWIGEXPORT SwigClassWrapper _wrap_TpetraMultiVector_subView(SwigClassWrapper con for (int i = 0; i < tmparr2.size(); i++) tmparr2[i] = tmpbegin2[i] - 1; tmpview2 = tmparr2(); - - // Make the input argument point to our temporary vector arg2 = &tmpview2; { // Make sure no unhandled exceptions exist before performing a new action @@ -4341,8 +4309,6 @@ SWIGEXPORT SwigClassWrapper _wrap_TpetraMultiVector_subViewNonConst(SwigClassWra for (int i = 0; i < tmparr2.size(); i++) tmparr2[i] = tmpbegin2[i] - 1; tmpview2 = tmparr2(); - - // Make the input argument point to our temporary vector arg2 = &tmpview2; { // Make sure no unhandled exceptions exist before performing a new action @@ -4540,14 +4506,12 @@ SWIGEXPORT void _wrap_TpetraMultiVector_get1dCopy(SwigClassWrapper const *farg1, Teuchos::ArrayView< double > *arg2 = 0 ; size_t arg3 ; Teuchos::RCP< Tpetra::MultiVector< SC,LO,GO,NO > const > *smartarg1 ; - double *tempbegin2 ; - Teuchos::ArrayView< double > temparr2 ; + Teuchos::ArrayView< double > tmparr2 ; smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); arg1 = smartarg1 ? const_cast< Tpetra::MultiVector* >(smartarg1->get()) : NULL; - tempbegin2 = static_cast(farg2->data); - temparr2 = Teuchos::ArrayView(tempbegin2, farg2->size); - arg2 = &temparr2; + tmparr2 = Teuchos::ArrayView(static_cast(farg2->data), farg2->size); + arg2 = &tmparr2; arg3 = static_cast< size_t >(*farg3); { // Make sure no unhandled exceptions exist before performing a new action @@ -4860,17 +4824,15 @@ SWIGEXPORT void _wrap_TpetraMultiVector_dot__SWIG_0(SwigClassWrapper const *farg Teuchos::ArrayView< Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::dot_type > *arg3 = 0 ; Teuchos::RCP< Tpetra::MultiVector< SC,LO,GO,NO > const > *smartarg1 ; Teuchos::RCP< Tpetra::MultiVector< SC,LO,GO,NO > const > *smartarg2 ; - double *tempbegin3 ; - Teuchos::ArrayView< double > temparr3 ; + Teuchos::ArrayView< double > tmparr3 ; smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); arg1 = smartarg1 ? const_cast< Tpetra::MultiVector* >(smartarg1->get()) : NULL; SWIG_check_sp_nonnull(farg2, "Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > *", "TpetraMultiVector", "Tpetra::MultiVector< SC,LO,GO,NO >::dot(Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &,Teuchos::ArrayView< Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::dot_type > const &) const", return ) smartarg2 = static_cast< Teuchos::RCP >* >(farg2->cptr); arg2 = const_cast< Tpetra::MultiVector* >(smartarg2->get()); - tempbegin3 = static_cast(farg3->data); - temparr3 = Teuchos::ArrayView(tempbegin3, farg3->size); - arg3 = &temparr3; + tmparr3 = Teuchos::ArrayView(static_cast(farg3->data), farg3->size); + arg3 = &tmparr3; { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::dot(Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &,Teuchos::ArrayView< Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::dot_type > const &) const");; @@ -5056,14 +5018,12 @@ SWIGEXPORT void _wrap_TpetraMultiVector_scale__SWIG_1(SwigClassWrapper const *fa Tpetra::MultiVector< SC,LO,GO,NO > *arg1 = (Tpetra::MultiVector< SC,LO,GO,NO > *) 0 ; Teuchos::ArrayView< double const > *arg2 = 0 ; Teuchos::RCP< Tpetra::MultiVector< SC,LO,GO,NO > > *smartarg1 ; - double const *tempbegin2 ; - Teuchos::ArrayView< double const > temparr2 ; + Teuchos::ArrayView< double const > tmparr2 ; smartarg1 = static_cast< Teuchos::RCP< Tpetra::MultiVector >* >(farg1->cptr); arg1 = smartarg1 ? const_cast< Tpetra::MultiVector* >(smartarg1->get()) : NULL; - tempbegin2 = static_cast(farg2->data); - temparr2 = Teuchos::ArrayView(tempbegin2, farg2->size); - arg2 = &temparr2; + tmparr2 = Teuchos::ArrayView(static_cast(farg2->data), farg2->size); + arg2 = &tmparr2; { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::scale(Teuchos::ArrayView< double const > const &)");; @@ -5274,14 +5234,12 @@ SWIGEXPORT void _wrap_TpetraMultiVector_norm1__SWIG_3(SwigClassWrapper const *fa Tpetra::MultiVector< SC,LO,GO,NO > *arg1 = (Tpetra::MultiVector< SC,LO,GO,NO > *) 0 ; Teuchos::ArrayView< Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::mag_type > *arg2 = 0 ; Teuchos::RCP< Tpetra::MultiVector< SC,LO,GO,NO > const > *smartarg1 ; - double *tempbegin2 ; - Teuchos::ArrayView< double > temparr2 ; + Teuchos::ArrayView< double > tmparr2 ; smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); arg1 = smartarg1 ? const_cast< Tpetra::MultiVector* >(smartarg1->get()) : NULL; - tempbegin2 = static_cast(farg2->data); - temparr2 = Teuchos::ArrayView(tempbegin2, farg2->size); - arg2 = &temparr2; + tmparr2 = Teuchos::ArrayView(static_cast(farg2->data), farg2->size); + arg2 = &tmparr2; { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::norm1(Teuchos::ArrayView< Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::mag_type > const &) const");; @@ -5349,14 +5307,12 @@ SWIGEXPORT void _wrap_TpetraMultiVector_norm2__SWIG_3(SwigClassWrapper const *fa Tpetra::MultiVector< SC,LO,GO,NO > *arg1 = (Tpetra::MultiVector< SC,LO,GO,NO > *) 0 ; Teuchos::ArrayView< Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::mag_type > *arg2 = 0 ; Teuchos::RCP< Tpetra::MultiVector< SC,LO,GO,NO > const > *smartarg1 ; - double *tempbegin2 ; - Teuchos::ArrayView< double > temparr2 ; + Teuchos::ArrayView< double > tmparr2 ; smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); arg1 = smartarg1 ? const_cast< Tpetra::MultiVector* >(smartarg1->get()) : NULL; - tempbegin2 = static_cast(farg2->data); - temparr2 = Teuchos::ArrayView(tempbegin2, farg2->size); - arg2 = &temparr2; + tmparr2 = Teuchos::ArrayView(static_cast(farg2->data), farg2->size); + arg2 = &tmparr2; { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::norm2(Teuchos::ArrayView< Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::mag_type > const &) const");; @@ -5424,14 +5380,12 @@ SWIGEXPORT void _wrap_TpetraMultiVector_normInf__SWIG_3(SwigClassWrapper const * Tpetra::MultiVector< SC,LO,GO,NO > *arg1 = (Tpetra::MultiVector< SC,LO,GO,NO > *) 0 ; Teuchos::ArrayView< Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::mag_type > *arg2 = 0 ; Teuchos::RCP< Tpetra::MultiVector< SC,LO,GO,NO > const > *smartarg1 ; - double *tempbegin2 ; - Teuchos::ArrayView< double > temparr2 ; + Teuchos::ArrayView< double > tmparr2 ; smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); arg1 = smartarg1 ? const_cast< Tpetra::MultiVector* >(smartarg1->get()) : NULL; - tempbegin2 = static_cast(farg2->data); - temparr2 = Teuchos::ArrayView(tempbegin2, farg2->size); - arg2 = &temparr2; + tmparr2 = Teuchos::ArrayView(static_cast(farg2->data), farg2->size); + arg2 = &tmparr2; { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::normInf(Teuchos::ArrayView< Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::mag_type > const &) const");; @@ -5463,14 +5417,12 @@ SWIGEXPORT void _wrap_TpetraMultiVector_meanValue(SwigClassWrapper const *farg1, Tpetra::MultiVector< SC,LO,GO,NO > *arg1 = (Tpetra::MultiVector< SC,LO,GO,NO > *) 0 ; Teuchos::ArrayView< Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::impl_scalar_type > *arg2 = 0 ; Teuchos::RCP< Tpetra::MultiVector< SC,LO,GO,NO > const > *smartarg1 ; - double *tempbegin2 ; - Teuchos::ArrayView< double > temparr2 ; + Teuchos::ArrayView< double > tmparr2 ; smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); arg1 = smartarg1 ? const_cast< Tpetra::MultiVector* >(smartarg1->get()) : NULL; - tempbegin2 = static_cast(farg2->data); - temparr2 = Teuchos::ArrayView(tempbegin2, farg2->size); - arg2 = &temparr2; + tmparr2 = Teuchos::ArrayView(static_cast(farg2->data), farg2->size); + arg2 = &tmparr2; { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::meanValue(Teuchos::ArrayView< Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::impl_scalar_type > const &) const");; @@ -7029,7 +6981,46 @@ SWIGEXPORT SwigClassWrapper _wrap_TpetraCrsGraph_getValidParameters(SwigClassWra } -SWIGEXPORT void _wrap_TpetraCrsGraph_insertGlobalIndices__SWIG_0(SwigClassWrapper const *farg1, long long const *farg2, int const *farg3, long long const *farg4) { +SWIGEXPORT void _wrap_TpetraCrsGraph_insertGlobalIndices__SWIG_0(SwigClassWrapper const *farg1, long long const *farg2, SwigArrayWrapper *farg3) { + Tpetra::CrsGraph< LO,GO,NO > *arg1 = (Tpetra::CrsGraph< LO,GO,NO > *) 0 ; + long long arg2 ; + Teuchos::ArrayView< long long const > *arg3 = 0 ; + Teuchos::RCP< Tpetra::CrsGraph< LO,GO,NO > > *smartarg1 ; + Teuchos::ArrayView< long long const > tmparr3 ; + + smartarg1 = static_cast< Teuchos::RCP< Tpetra::CrsGraph >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::CrsGraph* >(smartarg1->get()) : NULL; + arg2 = static_cast< long long >(*farg2); + tmparr3 = Teuchos::ArrayView(static_cast(farg3->data), farg3->size); + arg3 = &tmparr3; + { + // Make sure no unhandled exceptions exist before performing a new action + SWIG_check_unhandled_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::insertGlobalIndices(long long const,Teuchos::ArrayView< long long const > const &)");; + try + { + // Attempt the wrapped function call + (arg1)->insertGlobalIndices(arg2,(Teuchos::ArrayView< long long const > const &)*arg3); + } + catch (const std::range_error& e) + { + // Store a C++ exception + SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::insertGlobalIndices(long long const,Teuchos::ArrayView< long long const > const &)", SWIG_IndexError, e.what(), return ); + } + catch (const std::exception& e) + { + // Store a C++ exception + SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::insertGlobalIndices(long long const,Teuchos::ArrayView< long long const > const &)", SWIG_RuntimeError, e.what(), return ); + } + catch (...) + { + SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::insertGlobalIndices(long long const,Teuchos::ArrayView< long long const > const &)", SWIG_UnknownError, "An unknown exception occurred", return ); + } + } + +} + + +SWIGEXPORT void _wrap_TpetraCrsGraph_insertGlobalIndices__SWIG_1(SwigClassWrapper const *farg1, long long const *farg2, int const *farg3, long long const *farg4) { Tpetra::CrsGraph< LO,GO,NO > *arg1 = (Tpetra::CrsGraph< LO,GO,NO > *) 0 ; long long arg2 ; int arg3 ; @@ -7068,6 +7059,51 @@ SWIGEXPORT void _wrap_TpetraCrsGraph_insertGlobalIndices__SWIG_0(SwigClassWrappe } +SWIGEXPORT void _wrap_TpetraCrsGraph_insertLocalIndices(SwigClassWrapper const *farg1, int const *farg2, SwigArrayWrapper *farg3) { + Tpetra::CrsGraph< LO,GO,NO > *arg1 = (Tpetra::CrsGraph< LO,GO,NO > *) 0 ; + int arg2 ; + Teuchos::ArrayView< int const > *arg3 = 0 ; + Teuchos::RCP< Tpetra::CrsGraph< LO,GO,NO > > *smartarg1 ; + Teuchos::ArrayView< int const >::value_type *tmpbegin3 ; + Teuchos::Array< std::remove_const< Teuchos::ArrayView< int const >::value_type >::type > tmparr3 ; + Teuchos::ArrayView< int const > tmpview3 ; + + smartarg1 = static_cast< Teuchos::RCP< Tpetra::CrsGraph >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::CrsGraph* >(smartarg1->get()) : NULL; + arg2 = *farg2 - 1; + tmpbegin3 = static_cast::value_type*>(farg3->data); + tmparr3.resize(farg3->size); + for (int i = 0; i < tmparr3.size(); i++) + tmparr3[i] = tmpbegin3[i] - 1; + tmpview3 = tmparr3(); + arg3 = &tmpview3; + { + // Make sure no unhandled exceptions exist before performing a new action + SWIG_check_unhandled_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::insertLocalIndices(int const,Teuchos::ArrayView< int const > const &)");; + try + { + // Attempt the wrapped function call + (arg1)->insertLocalIndices(arg2,(Teuchos::ArrayView< int const > const &)*arg3); + } + catch (const std::range_error& e) + { + // Store a C++ exception + SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::insertLocalIndices(int const,Teuchos::ArrayView< int const > const &)", SWIG_IndexError, e.what(), return ); + } + catch (const std::exception& e) + { + // Store a C++ exception + SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::insertLocalIndices(int const,Teuchos::ArrayView< int const > const &)", SWIG_RuntimeError, e.what(), return ); + } + catch (...) + { + SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::insertLocalIndices(int const,Teuchos::ArrayView< int const > const &)", SWIG_UnknownError, "An unknown exception occurred", return ); + } + } + +} + + SWIGEXPORT void _wrap_TpetraCrsGraph_removeLocalIndices(SwigClassWrapper const *farg1, int const *farg2) { Tpetra::CrsGraph< LO,GO,NO > *arg1 = (Tpetra::CrsGraph< LO,GO,NO > *) 0 ; int arg2 ; @@ -8702,15 +8738,13 @@ SWIGEXPORT void _wrap_TpetraCrsGraph_getGlobalRowCopy(SwigClassWrapper const *fa Teuchos::ArrayView< long long > *arg3 = 0 ; size_t *arg4 = 0 ; Teuchos::RCP< Tpetra::CrsGraph< LO,GO,NO > const > *smartarg1 ; - long long *tempbegin3 ; - Teuchos::ArrayView< long long > temparr3 ; + Teuchos::ArrayView< long long > tmparr3 ; smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); arg1 = smartarg1 ? const_cast< Tpetra::CrsGraph* >(smartarg1->get()) : NULL; arg2 = static_cast< long long >(*farg2); - tempbegin3 = static_cast(farg3->data); - temparr3 = Teuchos::ArrayView(tempbegin3, farg3->size); - arg3 = &temparr3; + tmparr3 = Teuchos::ArrayView(static_cast(farg3->data), farg3->size); + arg3 = &tmparr3; arg4 = reinterpret_cast< size_t * >(farg4); { // Make sure no unhandled exceptions exist before performing a new action @@ -8739,6 +8773,49 @@ SWIGEXPORT void _wrap_TpetraCrsGraph_getGlobalRowCopy(SwigClassWrapper const *fa } +SWIGEXPORT void _wrap_TpetraCrsGraph_getLocalRowCopy(SwigClassWrapper const *farg1, int const *farg2, SwigArrayWrapper *farg3, size_t *farg4) { + Tpetra::CrsGraph< LO,GO,NO > *arg1 = (Tpetra::CrsGraph< LO,GO,NO > *) 0 ; + int arg2 ; + Teuchos::ArrayView< int > *arg3 = 0 ; + size_t *arg4 = 0 ; + Teuchos::RCP< Tpetra::CrsGraph< LO,GO,NO > const > *smartarg1 ; + Teuchos::ArrayView< int > tmparr3 ; + + smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::CrsGraph* >(smartarg1->get()) : NULL; + arg2 = *farg2 - 1; + tmparr3 = Teuchos::ArrayView(static_cast(farg3->data), farg3->size); + arg3 = &tmparr3; + arg4 = reinterpret_cast< size_t * >(farg4); + { + // Make sure no unhandled exceptions exist before performing a new action + SWIG_check_unhandled_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::getLocalRowCopy(int,Teuchos::ArrayView< int > const &,size_t &) const");; + try + { + // Attempt the wrapped function call + ((Tpetra::CrsGraph< LO,GO,NO > const *)arg1)->getLocalRowCopy(arg2,(Teuchos::ArrayView< int > const &)*arg3,*arg4); + } + catch (const std::range_error& e) + { + // Store a C++ exception + SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::getLocalRowCopy(int,Teuchos::ArrayView< int > const &,size_t &) const", SWIG_IndexError, e.what(), return ); + } + catch (const std::exception& e) + { + // Store a C++ exception + SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::getLocalRowCopy(int,Teuchos::ArrayView< int > const &,size_t &) const", SWIG_RuntimeError, e.what(), return ); + } + catch (...) + { + SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::getLocalRowCopy(int,Teuchos::ArrayView< int > const &,size_t &) const", SWIG_UnknownError, "An unknown exception occurred", return ); + } + } + + for (int i = 0; i < tmparr3.size(); i++) + tmparr3[i] += 1; +} + + SWIGEXPORT int _wrap_TpetraCrsGraph_supportsRowViews(SwigClassWrapper const *farg1) { int fresult ; Tpetra::CrsGraph< LO,GO,NO > *arg1 = (Tpetra::CrsGraph< LO,GO,NO > *) 0 ; @@ -9511,13 +9588,11 @@ SWIGEXPORT SwigClassWrapper _wrap_new_TpetraCrsGraph__SWIG_6(SwigClassWrapper co Tpetra::ProfileType arg3 ; Teuchos::RCP< Teuchos::ParameterList > *arg4 = 0 ; Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > tempnull1 ; - unsigned long const *tempbegin2 ; Teuchos::RCP< Teuchos::ParameterList > tempnull4 ; Tpetra::CrsGraph< LO,GO,NO > *result = 0 ; arg1 = farg1->cptr ? static_cast< Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg1->cptr) : &tempnull1; - tempbegin2 = static_cast(farg2->data); - arg2 = Teuchos::ArrayView(tempbegin2, farg2->size); + arg2 = Teuchos::ArrayView(static_cast(farg2->data), farg2->size); arg3 = static_cast< Tpetra::ProfileType >(*farg3); arg4 = farg4->cptr ? static_cast< Teuchos::RCP< Teuchos::ParameterList > * >(farg4->cptr) : &tempnull4; { @@ -9555,12 +9630,10 @@ SWIGEXPORT SwigClassWrapper _wrap_new_TpetraCrsGraph__SWIG_7(SwigClassWrapper co Teuchos::ArrayView< std::size_t const > arg2 ; Tpetra::ProfileType arg3 ; Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > tempnull1 ; - unsigned long const *tempbegin2 ; Tpetra::CrsGraph< LO,GO,NO > *result = 0 ; arg1 = farg1->cptr ? static_cast< Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg1->cptr) : &tempnull1; - tempbegin2 = static_cast(farg2->data); - arg2 = Teuchos::ArrayView(tempbegin2, farg2->size); + arg2 = Teuchos::ArrayView(static_cast(farg2->data), farg2->size); arg3 = static_cast< Tpetra::ProfileType >(*farg3); { // Make sure no unhandled exceptions exist before performing a new action @@ -9596,12 +9669,10 @@ SWIGEXPORT SwigClassWrapper _wrap_new_TpetraCrsGraph__SWIG_8(SwigClassWrapper co Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > *arg1 = 0 ; Teuchos::ArrayView< std::size_t const > arg2 ; Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > tempnull1 ; - unsigned long const *tempbegin2 ; Tpetra::CrsGraph< LO,GO,NO > *result = 0 ; arg1 = farg1->cptr ? static_cast< Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg1->cptr) : &tempnull1; - tempbegin2 = static_cast(farg2->data); - arg2 = Teuchos::ArrayView(tempbegin2, farg2->size); + arg2 = Teuchos::ArrayView(static_cast(farg2->data), farg2->size); { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::CrsGraph(Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::ArrayView< std::size_t const >)");; @@ -9640,14 +9711,12 @@ SWIGEXPORT SwigClassWrapper _wrap_new_TpetraCrsGraph__SWIG_9(SwigClassWrapper co Teuchos::RCP< Teuchos::ParameterList > *arg5 = 0 ; Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > tempnull1 ; Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > tempnull2 ; - unsigned long const *tempbegin3 ; Teuchos::RCP< Teuchos::ParameterList > tempnull5 ; Tpetra::CrsGraph< LO,GO,NO > *result = 0 ; arg1 = farg1->cptr ? static_cast< Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg1->cptr) : &tempnull1; arg2 = farg2->cptr ? static_cast< Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg2->cptr) : &tempnull2; - tempbegin3 = static_cast(farg3->data); - arg3 = Teuchos::ArrayView(tempbegin3, farg3->size); + arg3 = Teuchos::ArrayView(static_cast(farg3->data), farg3->size); arg4 = static_cast< Tpetra::ProfileType >(*farg4); arg5 = farg5->cptr ? static_cast< Teuchos::RCP< Teuchos::ParameterList > * >(farg5->cptr) : &tempnull5; { @@ -9687,13 +9756,11 @@ SWIGEXPORT SwigClassWrapper _wrap_new_TpetraCrsGraph__SWIG_10(SwigClassWrapper c Tpetra::ProfileType arg4 ; Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > tempnull1 ; Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > tempnull2 ; - unsigned long const *tempbegin3 ; Tpetra::CrsGraph< LO,GO,NO > *result = 0 ; arg1 = farg1->cptr ? static_cast< Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg1->cptr) : &tempnull1; arg2 = farg2->cptr ? static_cast< Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg2->cptr) : &tempnull2; - tempbegin3 = static_cast(farg3->data); - arg3 = Teuchos::ArrayView(tempbegin3, farg3->size); + arg3 = Teuchos::ArrayView(static_cast(farg3->data), farg3->size); arg4 = static_cast< Tpetra::ProfileType >(*farg4); { // Make sure no unhandled exceptions exist before performing a new action @@ -9731,13 +9798,11 @@ SWIGEXPORT SwigClassWrapper _wrap_new_TpetraCrsGraph__SWIG_11(SwigClassWrapper c Teuchos::ArrayView< std::size_t const > arg3 ; Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > tempnull1 ; Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > tempnull2 ; - unsigned long const *tempbegin3 ; Tpetra::CrsGraph< LO,GO,NO > *result = 0 ; arg1 = farg1->cptr ? static_cast< Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg1->cptr) : &tempnull1; arg2 = farg2->cptr ? static_cast< Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg2->cptr) : &tempnull2; - tempbegin3 = static_cast(farg3->data); - arg3 = Teuchos::ArrayView(tempbegin3, farg3->size); + arg3 = Teuchos::ArrayView(static_cast(farg3->data), farg3->size); { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::CrsGraph(Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::ArrayView< std::size_t const >)");; @@ -9776,17 +9841,13 @@ SWIGEXPORT SwigClassWrapper _wrap_new_TpetraCrsGraph__SWIG_12(SwigClassWrapper c Teuchos::RCP< Teuchos::ParameterList > *arg5 = 0 ; Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > tempnull1 ; Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > tempnull2 ; - unsigned long *tempbegin3 ; - int *tempbegin4 ; Teuchos::RCP< Teuchos::ParameterList > tempnull5 ; Tpetra::CrsGraph< LO,GO,NO > *result = 0 ; arg1 = farg1->cptr ? static_cast< Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg1->cptr) : &tempnull1; arg2 = farg2->cptr ? static_cast< Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg2->cptr) : &tempnull2; - tempbegin3 = static_cast(farg3->data); - arg3 = Teuchos::ArrayView(tempbegin3, farg3->size); - tempbegin4 = static_cast(farg4->data); - arg4 = Teuchos::ArrayView(tempbegin4, farg4->size); + arg3 = Teuchos::ArrayView(static_cast(farg3->data), farg3->size); + arg4 = Teuchos::ArrayView(static_cast(farg4->data), farg4->size); arg5 = farg5->cptr ? static_cast< Teuchos::RCP< Teuchos::ParameterList > * >(farg5->cptr) : &tempnull5; { // Make sure no unhandled exceptions exist before performing a new action @@ -9825,16 +9886,12 @@ SWIGEXPORT SwigClassWrapper _wrap_new_TpetraCrsGraph__SWIG_13(SwigClassWrapper c Teuchos::ArrayView< LO > arg4 ; Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > tempnull1 ; Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > tempnull2 ; - unsigned long *tempbegin3 ; - int *tempbegin4 ; Tpetra::CrsGraph< LO,GO,NO > *result = 0 ; arg1 = farg1->cptr ? static_cast< Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg1->cptr) : &tempnull1; arg2 = farg2->cptr ? static_cast< Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg2->cptr) : &tempnull2; - tempbegin3 = static_cast(farg3->data); - arg3 = Teuchos::ArrayView(tempbegin3, farg3->size); - tempbegin4 = static_cast(farg4->data); - arg4 = Teuchos::ArrayView(tempbegin4, farg4->size); + arg3 = Teuchos::ArrayView(static_cast(farg3->data), farg3->size); + arg4 = Teuchos::ArrayView(static_cast(farg4->data), farg4->size); { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::CrsGraph(Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::ArrayView< std::size_t >,Teuchos::ArrayView< LO >)");; @@ -9864,143 +9921,18 @@ SWIGEXPORT SwigClassWrapper _wrap_new_TpetraCrsGraph__SWIG_13(SwigClassWrapper c } -SWIGEXPORT void _wrap_TpetraCrsGraph_insertGlobalIndices__SWIG_1(SwigClassWrapper const *farg1, long long const *farg2, SwigArrayWrapper *farg3) { - Tpetra::CrsGraph< LO,GO,NO > *arg1 = (Tpetra::CrsGraph< LO,GO,NO > *) 0 ; - GO arg2 ; - Teuchos::ArrayView< GO const > arg3 ; - Teuchos::RCP< Tpetra::CrsGraph< LO,GO,NO > > *smartarg1 ; - long long const *tempbegin3 ; - - smartarg1 = static_cast< Teuchos::RCP< Tpetra::CrsGraph >* >(farg1->cptr); - arg1 = smartarg1 ? const_cast< Tpetra::CrsGraph* >(smartarg1->get()) : NULL; - arg2 = static_cast< GO >(*farg2); - tempbegin3 = static_cast(farg3->data); - arg3 = Teuchos::ArrayView(tempbegin3, farg3->size); - { - // Make sure no unhandled exceptions exist before performing a new action - SWIG_check_unhandled_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::insertGlobalIndices(GO const,Teuchos::ArrayView< GO const >)");; - try - { - // Attempt the wrapped function call - Tpetra_CrsGraph_Sl_LO_Sc_GO_Sc_NO_Sg__insertGlobalIndices__SWIG_1(arg1,arg2,arg3); - } - catch (const std::range_error& e) - { - // Store a C++ exception - SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::insertGlobalIndices(GO const,Teuchos::ArrayView< GO const >)", SWIG_IndexError, e.what(), return ); - } - catch (const std::exception& e) - { - // Store a C++ exception - SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::insertGlobalIndices(GO const,Teuchos::ArrayView< GO const >)", SWIG_RuntimeError, e.what(), return ); - } - catch (...) - { - SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::insertGlobalIndices(GO const,Teuchos::ArrayView< GO const >)", SWIG_UnknownError, "An unknown exception occurred", return ); - } - } - -} - - -SWIGEXPORT void _wrap_TpetraCrsGraph_insertLocalIndices(SwigClassWrapper const *farg1, int const *farg2, SwigArrayWrapper *farg3) { - Tpetra::CrsGraph< LO,GO,NO > *arg1 = (Tpetra::CrsGraph< LO,GO,NO > *) 0 ; - LO arg2 ; - Teuchos::ArrayView< LO const > arg3 ; - Teuchos::RCP< Tpetra::CrsGraph< LO,GO,NO > > *smartarg1 ; - int const *tempbegin3 ; - - smartarg1 = static_cast< Teuchos::RCP< Tpetra::CrsGraph >* >(farg1->cptr); - arg1 = smartarg1 ? const_cast< Tpetra::CrsGraph* >(smartarg1->get()) : NULL; - arg2 = *farg2 - 1; - tempbegin3 = static_cast(farg3->data); - arg3 = Teuchos::ArrayView(tempbegin3, farg3->size); - { - // Make sure no unhandled exceptions exist before performing a new action - SWIG_check_unhandled_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::insertLocalIndices(LO const,Teuchos::ArrayView< LO const >)");; - try - { - // Attempt the wrapped function call - Tpetra_CrsGraph_Sl_LO_Sc_GO_Sc_NO_Sg__insertLocalIndices(arg1,arg2,arg3); - } - catch (const std::range_error& e) - { - // Store a C++ exception - SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::insertLocalIndices(LO const,Teuchos::ArrayView< LO const >)", SWIG_IndexError, e.what(), return ); - } - catch (const std::exception& e) - { - // Store a C++ exception - SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::insertLocalIndices(LO const,Teuchos::ArrayView< LO const >)", SWIG_RuntimeError, e.what(), return ); - } - catch (...) - { - SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::insertLocalIndices(LO const,Teuchos::ArrayView< LO const >)", SWIG_UnknownError, "An unknown exception occurred", return ); - } - } - -} - - -SWIGEXPORT void _wrap_TpetraCrsGraph_getLocalRowCopy(SwigClassWrapper const *farg1, int const *farg2, SwigArrayWrapper *farg3, size_t *farg4) { - Tpetra::CrsGraph< LO,GO,NO > *arg1 = (Tpetra::CrsGraph< LO,GO,NO > *) 0 ; - LO arg2 ; - Teuchos::ArrayView< LO > arg3 ; - size_t *arg4 = 0 ; - Teuchos::RCP< Tpetra::CrsGraph< LO,GO,NO > const > *smartarg1 ; - int *tempbegin3 ; - - smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); - arg1 = smartarg1 ? const_cast< Tpetra::CrsGraph* >(smartarg1->get()) : NULL; - arg2 = *farg2 - 1; - tempbegin3 = static_cast(farg3->data); - arg3 = Teuchos::ArrayView(tempbegin3, farg3->size); - arg4 = reinterpret_cast< size_t * >(farg4); - { - // Make sure no unhandled exceptions exist before performing a new action - SWIG_check_unhandled_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::getLocalRowCopy(LO,Teuchos::ArrayView< LO >,size_t &) const");; - try - { - // Attempt the wrapped function call - Tpetra_CrsGraph_Sl_LO_Sc_GO_Sc_NO_Sg__getLocalRowCopy((Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const *)arg1,arg2,arg3,*arg4); - } - catch (const std::range_error& e) - { - // Store a C++ exception - SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::getLocalRowCopy(LO,Teuchos::ArrayView< LO >,size_t &) const", SWIG_IndexError, e.what(), return ); - } - catch (const std::exception& e) - { - // Store a C++ exception - SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::getLocalRowCopy(LO,Teuchos::ArrayView< LO >,size_t &) const", SWIG_RuntimeError, e.what(), return ); - } - catch (...) - { - SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::getLocalRowCopy(LO,Teuchos::ArrayView< LO >,size_t &) const", SWIG_UnknownError, "An unknown exception occurred", return ); - } - } - -} - - SWIGEXPORT void _wrap_TpetraCrsGraph_setAllIndices(SwigClassWrapper const *farg1, SwigArrayWrapper *farg2, SwigArrayWrapper *farg3, SwigArrayWrapper *farg4) { Tpetra::CrsGraph< LO,GO,NO > *arg1 = (Tpetra::CrsGraph< LO,GO,NO > *) 0 ; Teuchos::ArrayView< std::size_t > arg2 ; Teuchos::ArrayView< LO > arg3 ; Teuchos::ArrayView< SC > arg4 ; Teuchos::RCP< Tpetra::CrsGraph< LO,GO,NO > > *smartarg1 ; - unsigned long *tempbegin2 ; - int *tempbegin3 ; - double *tempbegin4 ; smartarg1 = static_cast< Teuchos::RCP< Tpetra::CrsGraph >* >(farg1->cptr); arg1 = smartarg1 ? const_cast< Tpetra::CrsGraph* >(smartarg1->get()) : NULL; - tempbegin2 = static_cast(farg2->data); - arg2 = Teuchos::ArrayView(tempbegin2, farg2->size); - tempbegin3 = static_cast(farg3->data); - arg3 = Teuchos::ArrayView(tempbegin3, farg3->size); - tempbegin4 = static_cast(farg4->data); - arg4 = Teuchos::ArrayView(tempbegin4, farg4->size); + arg2 = Teuchos::ArrayView(static_cast(farg2->data), farg2->size); + arg3 = Teuchos::ArrayView(static_cast(farg3->data), farg3->size); + arg4 = Teuchos::ArrayView(static_cast(farg4->data), farg4->size); { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::setAllIndices(Teuchos::ArrayView< std::size_t >,Teuchos::ArrayView< LO >,Teuchos::ArrayView< SC >)");; @@ -10032,12 +9964,10 @@ SWIGEXPORT void _wrap_TpetraCrsGraph_getNodeRowPtrs(SwigClassWrapper const *farg Tpetra::CrsGraph< LO,GO,NO > *arg1 = (Tpetra::CrsGraph< LO,GO,NO > *) 0 ; Teuchos::ArrayView< std::size_t > arg2 ; Teuchos::RCP< Tpetra::CrsGraph< LO,GO,NO > const > *smartarg1 ; - unsigned long *tempbegin2 ; smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); arg1 = smartarg1 ? const_cast< Tpetra::CrsGraph* >(smartarg1->get()) : NULL; - tempbegin2 = static_cast(farg2->data); - arg2 = Teuchos::ArrayView(tempbegin2, farg2->size); + arg2 = Teuchos::ArrayView(static_cast(farg2->data), farg2->size); { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::getNodeRowPtrs(Teuchos::ArrayView< std::size_t >) const");; @@ -10069,12 +9999,10 @@ SWIGEXPORT void _wrap_TpetraCrsGraph_getNodePackedIndices(SwigClassWrapper const Tpetra::CrsGraph< LO,GO,NO > *arg1 = (Tpetra::CrsGraph< LO,GO,NO > *) 0 ; Teuchos::ArrayView< std::size_t > arg2 ; Teuchos::RCP< Tpetra::CrsGraph< LO,GO,NO > const > *smartarg1 ; - unsigned long *tempbegin2 ; smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); arg1 = smartarg1 ? const_cast< Tpetra::CrsGraph* >(smartarg1->get()) : NULL; - tempbegin2 = static_cast(farg2->data); - arg2 = Teuchos::ArrayView(tempbegin2, farg2->size); + arg2 = Teuchos::ArrayView(static_cast(farg2->data), farg2->size); { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::getNodePackedIndices(Teuchos::ArrayView< std::size_t >) const");; @@ -10736,20 +10664,16 @@ SWIGEXPORT void _wrap_TpetraCrsMatrix_insertGlobalValues(SwigClassWrapper const Teuchos::ArrayView< long long const > *arg3 = 0 ; Teuchos::ArrayView< double const > *arg4 = 0 ; Teuchos::RCP< Tpetra::CrsMatrix< SC,LO,GO,NO > > *smartarg1 ; - long long const *tempbegin3 ; - Teuchos::ArrayView< long long const > temparr3 ; - double const *tempbegin4 ; - Teuchos::ArrayView< double const > temparr4 ; + Teuchos::ArrayView< long long const > tmparr3 ; + Teuchos::ArrayView< double const > tmparr4 ; smartarg1 = static_cast< Teuchos::RCP< Tpetra::CrsMatrix >* >(farg1->cptr); arg1 = smartarg1 ? const_cast< Tpetra::CrsMatrix* >(smartarg1->get()) : NULL; arg2 = static_cast< long long >(*farg2); - tempbegin3 = static_cast(farg3->data); - temparr3 = Teuchos::ArrayView(tempbegin3, farg3->size); - arg3 = &temparr3; - tempbegin4 = static_cast(farg4->data); - temparr4 = Teuchos::ArrayView(tempbegin4, farg4->size); - arg4 = &temparr4; + tmparr3 = Teuchos::ArrayView(static_cast(farg3->data), farg3->size); + arg3 = &tmparr3; + tmparr4 = Teuchos::ArrayView(static_cast(farg4->data), farg4->size); + arg4 = &tmparr4; { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::insertGlobalValues(long long const,Teuchos::ArrayView< long long const > const &,Teuchos::ArrayView< double const > const &)");; @@ -10784,21 +10708,17 @@ SWIGEXPORT int _wrap_TpetraCrsMatrix_replaceGlobalValues(SwigClassWrapper const Teuchos::ArrayView< long long const > *arg3 = 0 ; Teuchos::ArrayView< double const > *arg4 = 0 ; Teuchos::RCP< Tpetra::CrsMatrix< SC,LO,GO,NO > const > *smartarg1 ; - long long const *tempbegin3 ; - Teuchos::ArrayView< long long const > temparr3 ; - double const *tempbegin4 ; - Teuchos::ArrayView< double const > temparr4 ; + Teuchos::ArrayView< long long const > tmparr3 ; + Teuchos::ArrayView< double const > tmparr4 ; int result; smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); arg1 = smartarg1 ? const_cast< Tpetra::CrsMatrix* >(smartarg1->get()) : NULL; arg2 = static_cast< long long >(*farg2); - tempbegin3 = static_cast(farg3->data); - temparr3 = Teuchos::ArrayView(tempbegin3, farg3->size); - arg3 = &temparr3; - tempbegin4 = static_cast(farg4->data); - temparr4 = Teuchos::ArrayView(tempbegin4, farg4->size); - arg4 = &temparr4; + tmparr3 = Teuchos::ArrayView(static_cast(farg3->data), farg3->size); + arg3 = &tmparr3; + tmparr4 = Teuchos::ArrayView(static_cast(farg4->data), farg4->size); + arg4 = &tmparr4; { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::replaceGlobalValues(long long const,Teuchos::ArrayView< long long const > const &,Teuchos::ArrayView< double const > const &) const");; @@ -12589,20 +12509,16 @@ SWIGEXPORT void _wrap_TpetraCrsMatrix_getGlobalRowCopy(SwigClassWrapper const *f Teuchos::ArrayView< double > *arg4 = 0 ; size_t *arg5 = 0 ; Teuchos::RCP< Tpetra::CrsMatrix< SC,LO,GO,NO > const > *smartarg1 ; - long long *tempbegin3 ; - Teuchos::ArrayView< long long > temparr3 ; - double *tempbegin4 ; - Teuchos::ArrayView< double > temparr4 ; + Teuchos::ArrayView< long long > tmparr3 ; + Teuchos::ArrayView< double > tmparr4 ; smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); arg1 = smartarg1 ? const_cast< Tpetra::CrsMatrix* >(smartarg1->get()) : NULL; arg2 = static_cast< long long >(*farg2); - tempbegin3 = static_cast(farg3->data); - temparr3 = Teuchos::ArrayView(tempbegin3, farg3->size); - arg3 = &temparr3; - tempbegin4 = static_cast(farg4->data); - temparr4 = Teuchos::ArrayView(tempbegin4, farg4->size); - arg4 = &temparr4; + tmparr3 = Teuchos::ArrayView(static_cast(farg3->data), farg3->size); + arg3 = &tmparr3; + tmparr4 = Teuchos::ArrayView(static_cast(farg4->data), farg4->size); + arg4 = &tmparr4; arg5 = reinterpret_cast< size_t * >(farg5); { // Make sure no unhandled exceptions exist before performing a new action @@ -13587,13 +13503,11 @@ SWIGEXPORT SwigClassWrapper _wrap_new_TpetraCrsMatrix__SWIG_10(SwigClassWrapper Tpetra::ProfileType arg3 ; Teuchos::RCP< Teuchos::ParameterList > *arg4 = 0 ; Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > tempnull1 ; - unsigned long const *tempbegin2 ; Teuchos::RCP< Teuchos::ParameterList > tempnull4 ; Tpetra::CrsMatrix< SC,LO,GO,NO > *result = 0 ; arg1 = farg1->cptr ? static_cast< Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg1->cptr) : &tempnull1; - tempbegin2 = static_cast(farg2->data); - arg2 = Teuchos::ArrayView(tempbegin2, farg2->size); + arg2 = Teuchos::ArrayView(static_cast(farg2->data), farg2->size); arg3 = static_cast< Tpetra::ProfileType >(*farg3); arg4 = farg4->cptr ? static_cast< Teuchos::RCP< Teuchos::ParameterList > * >(farg4->cptr) : &tempnull4; { @@ -13631,12 +13545,10 @@ SWIGEXPORT SwigClassWrapper _wrap_new_TpetraCrsMatrix__SWIG_11(SwigClassWrapper Teuchos::ArrayView< std::size_t const > arg2 ; Tpetra::ProfileType arg3 ; Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > tempnull1 ; - unsigned long const *tempbegin2 ; Tpetra::CrsMatrix< SC,LO,GO,NO > *result = 0 ; arg1 = farg1->cptr ? static_cast< Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg1->cptr) : &tempnull1; - tempbegin2 = static_cast(farg2->data); - arg2 = Teuchos::ArrayView(tempbegin2, farg2->size); + arg2 = Teuchos::ArrayView(static_cast(farg2->data), farg2->size); arg3 = static_cast< Tpetra::ProfileType >(*farg3); { // Make sure no unhandled exceptions exist before performing a new action @@ -13672,12 +13584,10 @@ SWIGEXPORT SwigClassWrapper _wrap_new_TpetraCrsMatrix__SWIG_12(SwigClassWrapper Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > *arg1 = 0 ; Teuchos::ArrayView< std::size_t const > arg2 ; Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > tempnull1 ; - unsigned long const *tempbegin2 ; Tpetra::CrsMatrix< SC,LO,GO,NO > *result = 0 ; arg1 = farg1->cptr ? static_cast< Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg1->cptr) : &tempnull1; - tempbegin2 = static_cast(farg2->data); - arg2 = Teuchos::ArrayView(tempbegin2, farg2->size); + arg2 = Teuchos::ArrayView(static_cast(farg2->data), farg2->size); { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::CrsMatrix(Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::ArrayView< std::size_t const >)");; @@ -13716,14 +13626,12 @@ SWIGEXPORT SwigClassWrapper _wrap_new_TpetraCrsMatrix__SWIG_13(SwigClassWrapper Teuchos::RCP< Teuchos::ParameterList > *arg5 = 0 ; Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > tempnull1 ; Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > tempnull2 ; - unsigned long const *tempbegin3 ; Teuchos::RCP< Teuchos::ParameterList > tempnull5 ; Tpetra::CrsMatrix< SC,LO,GO,NO > *result = 0 ; arg1 = farg1->cptr ? static_cast< Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg1->cptr) : &tempnull1; arg2 = farg2->cptr ? static_cast< Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg2->cptr) : &tempnull2; - tempbegin3 = static_cast(farg3->data); - arg3 = Teuchos::ArrayView(tempbegin3, farg3->size); + arg3 = Teuchos::ArrayView(static_cast(farg3->data), farg3->size); arg4 = static_cast< Tpetra::ProfileType >(*farg4); arg5 = farg5->cptr ? static_cast< Teuchos::RCP< Teuchos::ParameterList > * >(farg5->cptr) : &tempnull5; { @@ -13763,13 +13671,11 @@ SWIGEXPORT SwigClassWrapper _wrap_new_TpetraCrsMatrix__SWIG_14(SwigClassWrapper Tpetra::ProfileType arg4 ; Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > tempnull1 ; Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > tempnull2 ; - unsigned long const *tempbegin3 ; Tpetra::CrsMatrix< SC,LO,GO,NO > *result = 0 ; arg1 = farg1->cptr ? static_cast< Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg1->cptr) : &tempnull1; arg2 = farg2->cptr ? static_cast< Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg2->cptr) : &tempnull2; - tempbegin3 = static_cast(farg3->data); - arg3 = Teuchos::ArrayView(tempbegin3, farg3->size); + arg3 = Teuchos::ArrayView(static_cast(farg3->data), farg3->size); arg4 = static_cast< Tpetra::ProfileType >(*farg4); { // Make sure no unhandled exceptions exist before performing a new action @@ -13807,13 +13713,11 @@ SWIGEXPORT SwigClassWrapper _wrap_new_TpetraCrsMatrix__SWIG_15(SwigClassWrapper Teuchos::ArrayView< std::size_t const > arg3 ; Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > tempnull1 ; Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > tempnull2 ; - unsigned long const *tempbegin3 ; Tpetra::CrsMatrix< SC,LO,GO,NO > *result = 0 ; arg1 = farg1->cptr ? static_cast< Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg1->cptr) : &tempnull1; arg2 = farg2->cptr ? static_cast< Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg2->cptr) : &tempnull2; - tempbegin3 = static_cast(farg3->data); - arg3 = Teuchos::ArrayView(tempbegin3, farg3->size); + arg3 = Teuchos::ArrayView(static_cast(farg3->data), farg3->size); { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::CrsMatrix(Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::ArrayView< std::size_t const >)");; @@ -13853,20 +13757,14 @@ SWIGEXPORT SwigClassWrapper _wrap_new_TpetraCrsMatrix__SWIG_16(SwigClassWrapper Teuchos::RCP< Teuchos::ParameterList > *arg6 = 0 ; Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > tempnull1 ; Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > tempnull2 ; - unsigned long *tempbegin3 ; - int *tempbegin4 ; - double *tempbegin5 ; Teuchos::RCP< Teuchos::ParameterList > tempnull6 ; Tpetra::CrsMatrix< SC,LO,GO,NO > *result = 0 ; arg1 = farg1->cptr ? static_cast< Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg1->cptr) : &tempnull1; arg2 = farg2->cptr ? static_cast< Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg2->cptr) : &tempnull2; - tempbegin3 = static_cast(farg3->data); - arg3 = Teuchos::ArrayView(tempbegin3, farg3->size); - tempbegin4 = static_cast(farg4->data); - arg4 = Teuchos::ArrayView(tempbegin4, farg4->size); - tempbegin5 = static_cast(farg5->data); - arg5 = Teuchos::ArrayView(tempbegin5, farg5->size); + arg3 = Teuchos::ArrayView(static_cast(farg3->data), farg3->size); + arg4 = Teuchos::ArrayView(static_cast(farg4->data), farg4->size); + arg5 = Teuchos::ArrayView(static_cast(farg5->data), farg5->size); arg6 = farg6->cptr ? static_cast< Teuchos::RCP< Teuchos::ParameterList > * >(farg6->cptr) : &tempnull6; { // Make sure no unhandled exceptions exist before performing a new action @@ -13906,19 +13804,13 @@ SWIGEXPORT SwigClassWrapper _wrap_new_TpetraCrsMatrix__SWIG_17(SwigClassWrapper Teuchos::ArrayView< SC > arg5 ; Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > tempnull1 ; Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > tempnull2 ; - unsigned long *tempbegin3 ; - int *tempbegin4 ; - double *tempbegin5 ; Tpetra::CrsMatrix< SC,LO,GO,NO > *result = 0 ; arg1 = farg1->cptr ? static_cast< Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg1->cptr) : &tempnull1; arg2 = farg2->cptr ? static_cast< Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg2->cptr) : &tempnull2; - tempbegin3 = static_cast(farg3->data); - arg3 = Teuchos::ArrayView(tempbegin3, farg3->size); - tempbegin4 = static_cast(farg4->data); - arg4 = Teuchos::ArrayView(tempbegin4, farg4->size); - tempbegin5 = static_cast(farg5->data); - arg5 = Teuchos::ArrayView(tempbegin5, farg5->size); + arg3 = Teuchos::ArrayView(static_cast(farg3->data), farg3->size); + arg4 = Teuchos::ArrayView(static_cast(farg4->data), farg4->size); + arg5 = Teuchos::ArrayView(static_cast(farg5->data), farg5->size); { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::CrsMatrix(Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::ArrayView< std::size_t >,Teuchos::ArrayView< LO >,Teuchos::ArrayView< SC >)");; @@ -13954,16 +13846,12 @@ SWIGEXPORT void _wrap_TpetraCrsMatrix_insertLocalValues(SwigClassWrapper const * Teuchos::ArrayView< LO const > arg3 ; Teuchos::ArrayView< SC const > arg4 ; Teuchos::RCP< Tpetra::CrsMatrix< SC,LO,GO,NO > > *smartarg1 ; - int const *tempbegin3 ; - double const *tempbegin4 ; smartarg1 = static_cast< Teuchos::RCP< Tpetra::CrsMatrix >* >(farg1->cptr); arg1 = smartarg1 ? const_cast< Tpetra::CrsMatrix* >(smartarg1->get()) : NULL; arg2 = *farg2 - 1; - tempbegin3 = static_cast(farg3->data); - arg3 = Teuchos::ArrayView(tempbegin3, farg3->size); - tempbegin4 = static_cast(farg4->data); - arg4 = Teuchos::ArrayView(tempbegin4, farg4->size); + arg3 = Teuchos::ArrayView(static_cast(farg3->data), farg3->size); + arg4 = Teuchos::ArrayView(static_cast(farg4->data), farg4->size); { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::insertLocalValues(LO const,Teuchos::ArrayView< LO const >,Teuchos::ArrayView< SC const >)");; @@ -13998,17 +13886,13 @@ SWIGEXPORT int _wrap_TpetraCrsMatrix_sumIntoGlobalValues(SwigClassWrapper const Teuchos::ArrayView< GO const > arg3 ; Teuchos::ArrayView< SC const > arg4 ; Teuchos::RCP< Tpetra::CrsMatrix< SC,LO,GO,NO > > *smartarg1 ; - long long const *tempbegin3 ; - double const *tempbegin4 ; LO result; smartarg1 = static_cast< Teuchos::RCP< Tpetra::CrsMatrix >* >(farg1->cptr); arg1 = smartarg1 ? const_cast< Tpetra::CrsMatrix* >(smartarg1->get()) : NULL; arg2 = static_cast< GO >(*farg2); - tempbegin3 = static_cast(farg3->data); - arg3 = Teuchos::ArrayView(tempbegin3, farg3->size); - tempbegin4 = static_cast(farg4->data); - arg4 = Teuchos::ArrayView(tempbegin4, farg4->size); + arg3 = Teuchos::ArrayView(static_cast(farg3->data), farg3->size); + arg4 = Teuchos::ArrayView(static_cast(farg4->data), farg4->size); { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::sumIntoGlobalValues(GO const,Teuchos::ArrayView< GO const >,Teuchos::ArrayView< SC const >)");; @@ -14043,18 +13927,12 @@ SWIGEXPORT void _wrap_TpetraCrsMatrix_setAllValues(SwigClassWrapper const *farg1 Teuchos::ArrayView< LO > arg3 ; Teuchos::ArrayView< SC > arg4 ; Teuchos::RCP< Tpetra::CrsMatrix< SC,LO,GO,NO > > *smartarg1 ; - unsigned long *tempbegin2 ; - int *tempbegin3 ; - double *tempbegin4 ; smartarg1 = static_cast< Teuchos::RCP< Tpetra::CrsMatrix >* >(farg1->cptr); arg1 = smartarg1 ? const_cast< Tpetra::CrsMatrix* >(smartarg1->get()) : NULL; - tempbegin2 = static_cast(farg2->data); - arg2 = Teuchos::ArrayView(tempbegin2, farg2->size); - tempbegin3 = static_cast(farg3->data); - arg3 = Teuchos::ArrayView(tempbegin3, farg3->size); - tempbegin4 = static_cast(farg4->data); - arg4 = Teuchos::ArrayView(tempbegin4, farg4->size); + arg2 = Teuchos::ArrayView(static_cast(farg2->data), farg2->size); + arg3 = Teuchos::ArrayView(static_cast(farg3->data), farg3->size); + arg4 = Teuchos::ArrayView(static_cast(farg4->data), farg4->size); { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::setAllValues(Teuchos::ArrayView< std::size_t >,Teuchos::ArrayView< LO >,Teuchos::ArrayView< SC >)");; @@ -14088,18 +13966,12 @@ SWIGEXPORT void _wrap_TpetraCrsMatrix_getAllValues(SwigClassWrapper const *farg1 Teuchos::ArrayView< LO > arg3 ; Teuchos::ArrayView< SC > arg4 ; Teuchos::RCP< Tpetra::CrsMatrix< SC,LO,GO,NO > const > *smartarg1 ; - unsigned long *tempbegin2 ; - int *tempbegin3 ; - double *tempbegin4 ; smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); arg1 = smartarg1 ? const_cast< Tpetra::CrsMatrix* >(smartarg1->get()) : NULL; - tempbegin2 = static_cast(farg2->data); - arg2 = Teuchos::ArrayView(tempbegin2, farg2->size); - tempbegin3 = static_cast(farg3->data); - arg3 = Teuchos::ArrayView(tempbegin3, farg3->size); - tempbegin4 = static_cast(farg4->data); - arg4 = Teuchos::ArrayView(tempbegin4, farg4->size); + arg2 = Teuchos::ArrayView(static_cast(farg2->data), farg2->size); + arg3 = Teuchos::ArrayView(static_cast(farg3->data), farg3->size); + arg4 = Teuchos::ArrayView(static_cast(farg4->data), farg4->size); { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::getAllValues(Teuchos::ArrayView< std::size_t >,Teuchos::ArrayView< LO >,Teuchos::ArrayView< SC >) const");; @@ -14134,16 +14006,12 @@ SWIGEXPORT void _wrap_TpetraCrsMatrix_getLocalRowCopy(SwigClassWrapper const *fa Teuchos::ArrayView< SC > arg4 ; size_t *arg5 = 0 ; Teuchos::RCP< Tpetra::CrsMatrix< SC,LO,GO,NO > const > *smartarg1 ; - int *tempbegin3 ; - double *tempbegin4 ; smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); arg1 = smartarg1 ? const_cast< Tpetra::CrsMatrix* >(smartarg1->get()) : NULL; arg2 = *farg2 - 1; - tempbegin3 = static_cast(farg3->data); - arg3 = Teuchos::ArrayView(tempbegin3, farg3->size); - tempbegin4 = static_cast(farg4->data); - arg4 = Teuchos::ArrayView(tempbegin4, farg4->size); + arg3 = Teuchos::ArrayView(static_cast(farg3->data), farg3->size); + arg4 = Teuchos::ArrayView(static_cast(farg4->data), farg4->size); arg5 = reinterpret_cast< size_t * >(farg5); { // Make sure no unhandled exceptions exist before performing a new action From 946af091840381c942a71e1119c5dc74a9ee9e63 Mon Sep 17 00:00:00 2001 From: Seth R Johnson Date: Sun, 3 Feb 2019 06:18:04 -0500 Subject: [PATCH 14/40] Replace "self" with "$self" --- src/tpetra/src/Tpetra_CrsMatrix.i | 22 +++++++++++----------- src/tpetra/src/Tpetra_MultiVector.i | 8 ++++---- 2 files changed, 15 insertions(+), 15 deletions(-) diff --git a/src/tpetra/src/Tpetra_CrsMatrix.i b/src/tpetra/src/Tpetra_CrsMatrix.i index a8d1c9d0..773ffd47 100644 --- a/src/tpetra/src/Tpetra_CrsMatrix.i +++ b/src/tpetra/src/Tpetra_CrsMatrix.i @@ -111,23 +111,23 @@ for (int i = 0; i < colsArray.size(); i++) colsArray[i] = cols[i] - 1; Teuchos::ArrayView valsView = Teuchos::arrayView(vals.getRawPtr(), vals.size()); - self->insertLocalValues(localRow, colsArray, valsView); + $self->insertLocalValues(localRow, colsArray, valsView); } LO replaceLocalValues(const LO localRow, Teuchos::ArrayView cols, Teuchos::ArrayView vals) const { Teuchos::Array colsArray(cols.size()); for (int i = 0; i < colsArray.size(); i++) colsArray[i] = cols[i] - 1; - return self->replaceLocalValues(localRow, colsArray, vals); + return $self->replaceLocalValues(localRow, colsArray, vals); } LO sumIntoGlobalValues(const GO globalRow, Teuchos::ArrayView cols, Teuchos::ArrayView vals) { - return self->sumIntoGlobalValues(globalRow, cols, vals, false); // TODO: for now, we only run in serial, no atomics necessary + return $self->sumIntoGlobalValues(globalRow, cols, vals, false); // TODO: for now, we only run in serial, no atomics necessary } LO sumIntoLocalValues(const LO localRow, Teuchos::ArrayView cols, Teuchos::ArrayView vals) const { Teuchos::Array colsArray(cols.size()); for (int i = 0; i < colsArray.size(); i++) colsArray[i] = cols[i] - 1; Teuchos::ArrayView valsView = Teuchos::arrayView(vals.getRawPtr(), vals.size()); - return self->sumIntoLocalValues(localRow, colsArray, valsView, false/*atomic*/); // TODO: for now, we only run in serial, no atomics necessary + return $self->sumIntoLocalValues(localRow, colsArray, valsView, false/*atomic*/); // TODO: for now, we only run in serial, no atomics necessary } void setAllValues(Teuchos::ArrayView ptr, Teuchos::ArrayView ind, Teuchos::ArrayView val) { Teuchos::ArrayRCP ptrArrayRCP(ptr.size()); @@ -137,14 +137,14 @@ for (int i = 0; i < indArrayRCP.size(); i++) indArrayRCP[i] = ind[i]-1; Teuchos::ArrayRCP valArrayRCP(val.getRawPtr(), 0, val.size(), false/*has_ownership*/); - self->setAllValues(arcpFromArrayView(ptr), arcpFromArrayView(ind), arcpFromArrayView(val)); + $self->setAllValues(arcpFromArrayView(ptr), arcpFromArrayView(ind), arcpFromArrayView(val)); } // NOTE: This is semantically different function from Tpetra. Here, we *require* that user already allocated the arrays to store the data void getAllValues(Teuchos::ArrayView rowPointers, Teuchos::ArrayView columnIndices, Teuchos::ArrayView values) const { Teuchos::ArrayRCP rowPointersArrayRCP; Teuchos::ArrayRCP columnIndicesArrayRCP; Teuchos::ArrayRCP valuesArrayRCP; - self->getAllValues(rowPointersArrayRCP, columnIndicesArrayRCP, valuesArrayRCP); + $self->getAllValues(rowPointersArrayRCP, columnIndicesArrayRCP, valuesArrayRCP); TEUCHOS_TEST_FOR_EXCEPTION(rowPointersArrayRCP.size() != rowPointers.size(), std::runtime_error, "Wrong rowPointers size"); TEUCHOS_TEST_FOR_EXCEPTION(columnIndicesArrayRCP.size() != columnIndices.size(), std::runtime_error, "Wrong columnIndices size"); TEUCHOS_TEST_FOR_EXCEPTION(valuesArrayRCP.size() != values.size(), std::runtime_error, "Wrong values size"); @@ -158,22 +158,22 @@ } } void getLocalRowCopy(LO localRow, Teuchos::ArrayView colInds, Teuchos::ArrayView vals, size_t &NumIndices) const { - self->getLocalRowCopy(localRow, colInds, vals, NumIndices); + $self->getLocalRowCopy(localRow, colInds, vals, NumIndices); for (int i = 0; i < colInds.size(); i++) colInds[i]++; } void doImport (const Tpetra::CrsMatrix &source, const Tpetra::Import< LO, GO, NO > &importer, CombineMode CM) { - self->doImport(source, importer, CM); + $self->doImport(source, importer, CM); } void doImport (const Tpetra::CrsMatrix &source, const Tpetra::Export< LO, GO, NO > &exporter, CombineMode CM) { - self->doImport(source, exporter, CM); + $self->doImport(source, exporter, CM); } void doExport (const Tpetra::CrsMatrix &source, const Tpetra::Export< LO, GO, NO > &exporter, CombineMode CM) { - self->doExport(source, exporter, CM); + $self->doExport(source, exporter, CM); } void doExport (const Tpetra::CrsMatrix &source, const Tpetra::Import< LO, GO, NO > &importer, CombineMode CM) { - self->doExport(source, importer, CM); + $self->doExport(source, importer, CM); } } %ignore Tpetra::CrsMatrix::CrsMatrix (const Teuchos::RCP& rowMap, diff --git a/src/tpetra/src/Tpetra_MultiVector.i b/src/tpetra/src/Tpetra_MultiVector.i index 4601410f..6dfaa01c 100644 --- a/src/tpetra/src/Tpetra_MultiVector.i +++ b/src/tpetra/src/Tpetra_MultiVector.i @@ -67,16 +67,16 @@ %extend Tpetra::MultiVector { void doImport (const Tpetra::MultiVector &source, const Tpetra::Import< LO, GO, NO > &importer, CombineMode CM) { - self->doImport(source, importer, CM); + $self->doImport(source, importer, CM); } void doImport (const Tpetra::MultiVector &source, const Tpetra::Export< LO, GO, NO > &exporter, CombineMode CM) { - self->doImport(source, exporter, CM); + $self->doImport(source, exporter, CM); } void doExport (const Tpetra::MultiVector &source, const Tpetra::Export< LO, GO, NO > &exporter, CombineMode CM) { - self->doExport(source, exporter, CM); + $self->doExport(source, exporter, CM); } void doExport (const Tpetra::MultiVector &source, const Tpetra::Import< LO, GO, NO > &importer, CombineMode CM) { - self->doExport(source, importer, CM); + $self->doExport(source, importer, CM); } } From 30a42a894ba18ba7bb5572f91d336d4f1c110f3b Mon Sep 17 00:00:00 2001 From: Seth R Johnson Date: Mon, 4 Feb 2019 06:41:22 -0500 Subject: [PATCH 15/40] Wrap constants as Fortran literals --- src/teuchos/src/forteuchos.i | 3 +++ src/tpetra/src/Tpetra_Map.i | 6 ++---- src/tpetra/src/swig/fortpetra.F90 | 21 +++++++------------ src/tpetra/src/swig/fortpetraFORTRAN_wrap.cxx | 10 --------- swig_hash | 2 +- 5 files changed, 13 insertions(+), 29 deletions(-) diff --git a/src/teuchos/src/forteuchos.i b/src/teuchos/src/forteuchos.i index d48e024b..1985ae2d 100644 --- a/src/teuchos/src/forteuchos.i +++ b/src/teuchos/src/forteuchos.i @@ -9,6 +9,9 @@ %include %include +// By default, wrap all constants as Fortran literals +%fortranconst; + %include "ForTrilinosTeuchos_config.hpp" // Typedefs diff --git a/src/tpetra/src/Tpetra_Map.i b/src/tpetra/src/Tpetra_Map.i index a511eddf..900c46f3 100644 --- a/src/tpetra/src/Tpetra_Map.i +++ b/src/tpetra/src/Tpetra_Map.i @@ -15,10 +15,8 @@ #include "Tpetra_Map.hpp" %} -%insert("fdecl") %{ - integer(global_ordinal_type), parameter, public :: TPETRA_GLOBAL_INVALID = -1 - integer, parameter, public :: TPETRA_LOCAL_INVALID = 0 -%} +%constant GO TPETRA_GLOBAL_INVALID = -1; +%constant LO TPETRA_LOCAL_INVALID = 0; // ======================================================================= // Ignore permanently diff --git a/src/tpetra/src/swig/fortpetra.F90 b/src/tpetra/src/swig/fortpetra.F90 index 08780340..717fcb2e 100644 --- a/src/tpetra/src/swig/fortpetra.F90 +++ b/src/tpetra/src/swig/fortpetra.F90 @@ -42,14 +42,10 @@ module fortpetra public :: mag_type public :: norm_type - integer(C_INT), protected, public, & - bind(C, name="_wrap_TPETRA_THROWS_EFFICIENCY_WARNINGS") :: TPETRA_THROWS_EFFICIENCY_WARNINGS - integer(C_INT), protected, public, & - bind(C, name="_wrap_TPETRA_PRINTS_EFFICIENCY_WARNINGS") :: TPETRA_PRINTS_EFFICIENCY_WARNINGS - integer(C_INT), protected, public, & - bind(C, name="_wrap_TPETRA_THROWS_ABUSE_WARNINGS") :: TPETRA_THROWS_ABUSE_WARNINGS - integer(C_INT), protected, public, & - bind(C, name="_wrap_TPETRA_PRINTS_ABUSE_WARNINGS") :: TPETRA_PRINTS_ABUSE_WARNINGS + integer(C_INT), parameter, public :: TPETRA_THROWS_EFFICIENCY_WARNINGS = 0_C_INT + integer(C_INT), parameter, public :: TPETRA_PRINTS_EFFICIENCY_WARNINGS = 0_C_INT + integer(C_INT), parameter, public :: TPETRA_THROWS_ABUSE_WARNINGS = 0_C_INT + integer(C_INT), parameter, public :: TPETRA_PRINTS_ABUSE_WARNINGS = 0_C_INT ! enum Tpetra::LocalGlobal enum, bind(c) enumerator :: TpetraLocallyReplicated @@ -86,8 +82,7 @@ module fortpetra end enum integer, parameter, public :: TpetraESweepDirection = kind(TpetraForward) public :: TpetraForward, TpetraBackward, TpetraSymmetric - integer(C_INT), protected, public, & - bind(C, name="_wrap_TPETRA_USE_KOKKOS_DISTOBJECT") :: TPETRA_USE_KOKKOS_DISTOBJECT + integer(C_INT), parameter, public :: TPETRA_USE_KOKKOS_DISTOBJECT = 0_C_INT ! enum Tpetra::CombineMode enum, bind(c) enumerator :: TpetraADD @@ -116,10 +111,8 @@ module fortpetra end type public :: setCombineModeParameter public :: combineModeToString - - integer(global_ordinal_type), parameter, public :: TPETRA_GLOBAL_INVALID = -1 - integer, parameter, public :: TPETRA_LOCAL_INVALID = 0 - + integer(C_LONG_LONG), parameter, public :: TPETRA_GLOBAL_INVALID = -1_C_LONG_LONG + integer(C_INT), parameter, public :: TPETRA_LOCAL_INVALID = 0_C_INT ! class Tpetra::Map< LO,GO,NO > type, public :: TpetraMap type(SwigClassWrapper), public :: swigdata diff --git a/src/tpetra/src/swig/fortpetraFORTRAN_wrap.cxx b/src/tpetra/src/swig/fortpetraFORTRAN_wrap.cxx index 2e255aa5..14c08d96 100644 --- a/src/tpetra/src/swig/fortpetraFORTRAN_wrap.cxx +++ b/src/tpetra/src/swig/fortpetraFORTRAN_wrap.cxx @@ -918,16 +918,6 @@ SWIGINTERN void Tpetra_MatrixMarket_Writer_Sl_CMT_Sg__writeDenseFile__SWIG_1(std #ifdef __cplusplus extern "C" { #endif -SWIGEXPORT SWIGEXTERN int const _wrap_TPETRA_THROWS_EFFICIENCY_WARNINGS = static_cast< int >(0); - -SWIGEXPORT SWIGEXTERN int const _wrap_TPETRA_PRINTS_EFFICIENCY_WARNINGS = static_cast< int >(0); - -SWIGEXPORT SWIGEXTERN int const _wrap_TPETRA_THROWS_ABUSE_WARNINGS = static_cast< int >(0); - -SWIGEXPORT SWIGEXTERN int const _wrap_TPETRA_PRINTS_ABUSE_WARNINGS = static_cast< int >(0); - -SWIGEXPORT SWIGEXTERN int const _wrap_TPETRA_USE_KOKKOS_DISTOBJECT = static_cast< int >(0); - SWIGEXPORT void _wrap_setCombineModeParameter(SwigClassWrapper const *farg1, SwigArrayWrapper *farg2) { Teuchos::ParameterList *arg1 = 0 ; std::string *arg2 = 0 ; diff --git a/swig_hash b/swig_hash index 39cba436..8d9db618 100644 --- a/swig_hash +++ b/swig_hash @@ -1 +1 @@ -01c436496 +a2f974dc4cc7ea7289ef3abb3c8bcbef03b96fef From b184d60ecfb468c0cfd3bc803d0e34e996adc5a8 Mon Sep 17 00:00:00 2001 From: Seth R Johnson Date: Mon, 4 Feb 2019 09:58:55 -0500 Subject: [PATCH 16/40] Use typemaps for Map and CrsMatrix --- .../test/Tpetra_ModelEvaluator_1DFEM.F90 | 3 +- src/tpetra/src/Tpetra_CrsMatrix.i | 56 +- src/tpetra/src/Tpetra_Map.i | 43 +- src/tpetra/src/swig/fortpetra.F90 | 768 +++++++---- src/tpetra/src/swig/fortpetraFORTRAN_wrap.cxx | 1158 +++++++++++------ 5 files changed, 1271 insertions(+), 757 deletions(-) diff --git a/src/interface/test/Tpetra_ModelEvaluator_1DFEM.F90 b/src/interface/test/Tpetra_ModelEvaluator_1DFEM.F90 index 66985041..d3384b24 100644 --- a/src/interface/test/Tpetra_ModelEvaluator_1DFEM.F90 +++ b/src/interface/test/Tpetra_ModelEvaluator_1DFEM.F90 @@ -134,10 +134,9 @@ function new_TpetraModelEvaluator1DFEM(comm, num_global_elems, z_min, z_max) & type(TeuchosComm), intent(in) :: comm integer(global_size_type), intent(in) :: num_global_elems real(scalar_type), intent(in) :: z_min, z_max - integer :: i + integer :: i, num_overlap_nodes integer(global_size_type) :: num_nodes integer(global_ordinal_type) :: min_overlap_GID, gid - integer(size_type) :: num_overlap_nodes integer(size_type) :: num_vecs=1 integer(global_ordinal_type), allocatable :: node_gids(:) type(TpetraCrsGraph) :: graph diff --git a/src/tpetra/src/Tpetra_CrsMatrix.i b/src/tpetra/src/Tpetra_CrsMatrix.i index 773ffd47..0f117e6d 100644 --- a/src/tpetra/src/Tpetra_CrsMatrix.i +++ b/src/tpetra/src/Tpetra_CrsMatrix.i @@ -76,16 +76,25 @@ %ignore Tpetra::importAndFillCompleteCrsMatrix; %ignore Tpetra::exportAndFillCompleteCrsMatrix; +%ignore Tpetra::CrsMatrix::getLocalRowView; // ±1 issue +%ignore Tpetra::CrsMatrix::transformLocalValues; // ±1 issue + // ======================================================================= // Fix ±1 issues // ======================================================================= -%apply int INDEX { int localRow }; +%apply int INDEX { int localRow, int LocalRow }; -%ignore Tpetra::CrsMatrix::getLocalRowView; // ±1 issue -%ignore Tpetra::CrsMatrix::reorderedLocalGaussSeidel; // ±1 issue -%ignore Tpetra::CrsMatrix::replaceLocalValues; // ±1 issue -%ignore Tpetra::CrsMatrix::sumIntoLocalValues; // ±1 issue -%ignore Tpetra::CrsMatrix::transformLocalValues; // ±1 issue +%apply const Teuchos::ArrayView& INDEX { + const Teuchos::ArrayView& indices, + const Teuchos::ArrayView& cols, + Teuchos::ArrayView cols} + +%apply const Teuchos::ArrayView& INDEX { const Teuchos::ArrayView& colInds } + +// Don't use atomics for value summation +%typemap(in,numinputs=0) bool atomic { + $1 = false; +} // ======================================================================= // Make interface more Fortran friendly @@ -106,29 +115,6 @@ columnIndicesArrayRCP[i] = columnIndices[i]-1; return new Tpetra::CrsMatrix(rowMap, colMap, rowPointersArrayRCP, columnIndicesArrayRCP, arcpFromArrayView(values), params); } - void insertLocalValues(const LO localRow, Teuchos::ArrayView cols, Teuchos::ArrayView vals) { - Teuchos::Array colsArray(cols.size()); - for (int i = 0; i < colsArray.size(); i++) - colsArray[i] = cols[i] - 1; - Teuchos::ArrayView valsView = Teuchos::arrayView(vals.getRawPtr(), vals.size()); - $self->insertLocalValues(localRow, colsArray, valsView); - } - LO replaceLocalValues(const LO localRow, Teuchos::ArrayView cols, Teuchos::ArrayView vals) const { - Teuchos::Array colsArray(cols.size()); - for (int i = 0; i < colsArray.size(); i++) - colsArray[i] = cols[i] - 1; - return $self->replaceLocalValues(localRow, colsArray, vals); - } - LO sumIntoGlobalValues(const GO globalRow, Teuchos::ArrayView cols, Teuchos::ArrayView vals) { - return $self->sumIntoGlobalValues(globalRow, cols, vals, false); // TODO: for now, we only run in serial, no atomics necessary - } - LO sumIntoLocalValues(const LO localRow, Teuchos::ArrayView cols, Teuchos::ArrayView vals) const { - Teuchos::Array colsArray(cols.size()); - for (int i = 0; i < colsArray.size(); i++) - colsArray[i] = cols[i] - 1; - Teuchos::ArrayView valsView = Teuchos::arrayView(vals.getRawPtr(), vals.size()); - return $self->sumIntoLocalValues(localRow, colsArray, valsView, false/*atomic*/); // TODO: for now, we only run in serial, no atomics necessary - } void setAllValues(Teuchos::ArrayView ptr, Teuchos::ArrayView ind, Teuchos::ArrayView val) { Teuchos::ArrayRCP ptrArrayRCP(ptr.size()); for (int i = 0; i < ptrArrayRCP.size(); i++) @@ -157,12 +143,6 @@ values [i] = valuesArrayRCP[i]; } } - void getLocalRowCopy(LO localRow, Teuchos::ArrayView colInds, Teuchos::ArrayView vals, size_t &NumIndices) const { - $self->getLocalRowCopy(localRow, colInds, vals, NumIndices); - - for (int i = 0; i < colInds.size(); i++) - colInds[i]++; - } void doImport (const Tpetra::CrsMatrix &source, const Tpetra::Import< LO, GO, NO > &importer, CombineMode CM) { $self->doImport(source, importer, CM); } @@ -191,18 +171,12 @@ const Teuchos::ArrayRCP& columnIndices, const Teuchos::ArrayRCP& values, const Teuchos::RCP& params = Teuchos::null); // needs Teuchos::ArrayRCP -%ignore Tpetra::CrsMatrix::insertLocalValues (const LocalOrdinal localRow, const Teuchos::ArrayView< const LocalOrdinal > &cols, const Teuchos::ArrayView< const Scalar > &vals); -%ignore Tpetra::CrsMatrix::replaceLocalValues(const LocalOrdinal localRow, const Teuchos::ArrayView< const LocalOrdinal > &cols, const Teuchos::ArrayView< const Scalar > &vals) const; -%ignore Tpetra::CrsMatrix::sumIntoGlobalValues(const GlobalOrdinal globalRow, const Teuchos::ArrayView< const GlobalOrdinal > &cols, const Teuchos::ArrayView< const Scalar > &vals, const bool atomic=useAtomicUpdatesByDefault); %ignore Tpetra::CrsMatrix::setAllValues(const Teuchos::ArrayRCP< size_t > &ptr, const Teuchos::ArrayRCP< LocalOrdinal > &ind, const Teuchos::ArrayRCP< Scalar > &val); %ignore Tpetra::CrsMatrix::getAllValues(Teuchos::ArrayRCP< const size_t > &rowPointers, Teuchos::ArrayRCP< const LocalOrdinal > &columnIndices, Teuchos::ArrayRCP< const Scalar > &values) const; -%ignore Tpetra::CrsMatrix::getLocalRowCopy(LocalOrdinal localRow, const Teuchos::ArrayView< LocalOrdinal > &colInds, const Teuchos::ArrayView< Scalar > &vals, size_t &numEntries) const; -%ignore Tpetra::CrsMatrix::getLocalRowView(LocalOrdinal LocalRow, Teuchos::ArrayView< const LocalOrdinal > &indices, Teuchos::ArrayView< const Scalar > &values) const; %ignore Tpetra::CrsMatrix::getLocalRowViewRaw(const LocalOrdinal lclRow, LocalOrdinal &numEnt, const LocalOrdinal *&lclColInds, const Scalar *&vals) const; %ignore Tpetra::CrsMatrix::getAllValues (Teuchos::ArrayRCP& rowPointers, Teuchos::ArrayRCP& columnIndices, Teuchos::ArrayRCP& values) const; %ignore Tpetra::CrsMatrix::getLocalDiagOffsets; // needs Teuchos::ArrayRCP %ignore Tpetra::CrsMatrix::sumIntoLocalValues (const LocalOrdinal localRow, const typename UnmanagedView< LocalIndicesViewType >::type &inputInds, const typename UnmanagedView< ImplScalarViewType >::type &inputVals, const bool atomic=useAtomicUpdatesByDefault) const; -%ignore Tpetra::CrsMatrix::sumIntoLocalValues (const LocalOrdinal localRow, const Teuchos::ArrayView< const LocalOrdinal > &cols, const Teuchos::ArrayView< const Scalar > &vals, const bool atomic=useAtomicUpdatesByDefault) const; %ignore Tpetra::CrsMatrix::sumIntoLocalValues (const LocalOrdinal localRow, const LocalOrdinal numEnt, const Scalar vals[], const LocalOrdinal cols[], const bool atomic=useAtomicUpdatesByDefault); diff --git a/src/tpetra/src/Tpetra_Map.i b/src/tpetra/src/Tpetra_Map.i index 900c46f3..a980c550 100644 --- a/src/tpetra/src/Tpetra_Map.i +++ b/src/tpetra/src/Tpetra_Map.i @@ -37,41 +37,26 @@ %ignore Tpetra::Map::getLocalMap; // no need to expose this yet %ignore Tpetra::Map::getMyGlobalIndices; // return type is not exposed externally, requires using `auto`; for now, use getNodeElementList +// ======================================================================= +// Typemaps +// ======================================================================= + // Function signatures for local quantities are incorrectly declared as size_t %apply LO { size_t getNodeNumElements, size_t numLocalElements }; -// ======================================================================= -// Fix ±1 issues -// ======================================================================= -%typemap(in) int localIndex %{$1 = *$input - 1;%} -%typemap(out) int getMinLocalIndex %{$result = $1 + 1;%} -%typemap(out) int getMaxLocalIndex %{$result = $1 + 1;%} -%typemap(out) int getLocalElement %{$result = $1 + 1;%} -%typemap(argout) const Teuchos::ArrayView& nodeIDList %{ - for (int i = 0; i < $1->size(); i++) - (*$1)[i]++; -%} -%typemap(argout) const Teuchos::ArrayView& LIDList %{ - for (int i = 0; i < $1->size(); i++) - (*$1)[i]++; -%} +// Convert from C to/from Fortran indices +%apply int INDEX { int localIndex, int getMinLocalIndex, int getMaxLocalIndex, +int getLocalElement}; -%extend Tpetra::Map { - Map(global_size_t numGlobalElements, const Teuchos::RCP > &comm, LocalGlobal lg=GloballyDistributed) { - return new Tpetra::Map(numGlobalElements, 1/*indexBase*/, comm, lg); - } - Map(global_size_t numGlobalElements, size_t numLocalElements, const Teuchos::RCP > &comm) { - return new Tpetra::Map(numGlobalElements, numLocalElements, 1/*indexBase*/, comm); - } - Map(const global_size_t numGlobalElements, Teuchos::ArrayView indexList, const Teuchos::RCP< const Teuchos::Comm< int > > &comm) { - return new Tpetra::Map(numGlobalElements, indexList, 1/*indexBase*/, comm); - } -} +%apply const Teuchos::ArrayView& INDEX { const Teuchos::ArrayView& indices } -%ignore Tpetra::Map::Map(global_size_t numGlobalElements, GlobalOrdinal indexBase, const Teuchos::RCP > &comm, LocalGlobal lg=GloballyDistributed, const Teuchos::RCP &node=defaultArgNode()); -%ignore Tpetra::Map::Map(global_size_t numGlobalElements, size_t numLocalElements, GlobalOrdinal indexBase, const Teuchos::RCP > &comm, const Teuchos::RCP &node=defaultArgNode()); -%ignore Tpetra::Map::Map(const global_size_t numGlobalElements, const Teuchos::ArrayView< const GlobalOrdinal > &indexList, const GlobalOrdinal indexBase, const Teuchos::RCP< const Teuchos::Comm< int > > &comm, const Teuchos::RCP< Node > &node=defaultArgNode< Node >()); +%apply const Teuchos::ArrayView& INDEX { const Teuchos::ArrayView& nodeIDList, const Teuchos::ArrayView& LIDList } + +// Set indexBase to 1 (Fortran) and don't pass it to the user +%typemap(in,numinputs=0) long long indexBase { + $1 = 1; +} %include "Tpetra_Map_decl.hpp" diff --git a/src/tpetra/src/swig/fortpetra.F90 b/src/tpetra/src/swig/fortpetra.F90 index 717fcb2e..afb9ae8d 100644 --- a/src/tpetra/src/swig/fortpetra.F90 +++ b/src/tpetra/src/swig/fortpetra.F90 @@ -113,6 +113,9 @@ module fortpetra public :: combineModeToString integer(C_LONG_LONG), parameter, public :: TPETRA_GLOBAL_INVALID = -1_C_LONG_LONG integer(C_INT), parameter, public :: TPETRA_LOCAL_INVALID = 0_C_INT + type, public :: SWIGTYPE_Teuchos__RCPT_Kokkos__Compat__KokkosSerialWrapper9ZCDM + type(SwigClassWrapper), public :: swigdata + end type ! class Tpetra::Map< LO,GO,NO > type, public :: TpetraMap type(SwigClassWrapper), public :: swigdata @@ -155,6 +158,9 @@ module fortpetra module procedure new_TpetraMap__SWIG_2 module procedure new_TpetraMap__SWIG_3 module procedure new_TpetraMap__SWIG_4 + module procedure new_TpetraMap__SWIG_5 + module procedure new_TpetraMap__SWIG_6 + module procedure new_TpetraMap__SWIG_7 end interface type, public :: SWIGTYPE_ImportT_int_long_long_Kokkos__Compat__KokkosSeri1YW4XR type(SwigClassWrapper), public :: swigdata @@ -484,7 +490,12 @@ module fortpetra contains procedure :: release => delete_TpetraCrsMatrix procedure :: insertGlobalValues => swigf_TpetraCrsMatrix_insertGlobalValues + procedure :: insertLocalValues => swigf_TpetraCrsMatrix_insertLocalValues procedure :: replaceGlobalValues => swigf_TpetraCrsMatrix_replaceGlobalValues + procedure, private :: replaceLocalValues__SWIG_1 => swigf_TpetraCrsMatrix_replaceLocalValues__SWIG_1 + procedure, private :: replaceLocalValues__SWIG_2 => swigf_TpetraCrsMatrix_replaceLocalValues__SWIG_2 + procedure, private :: sumIntoGlobalValues__SWIG_0 => swigf_TpetraCrsMatrix_sumIntoGlobalValues__SWIG_0 + procedure, private :: sumIntoLocalValues__SWIG_0 => swigf_TpetraCrsMatrix_sumIntoLocalValues__SWIG_0 procedure :: setAllToScalar => swigf_TpetraCrsMatrix_setAllToScalar procedure :: scale => swigf_TpetraCrsMatrix_scale procedure :: globalAssemble => swigf_TpetraCrsMatrix_globalAssemble @@ -533,6 +544,7 @@ module fortpetra procedure :: getFrobeniusNorm => swigf_TpetraCrsMatrix_getFrobeniusNorm procedure :: supportsRowViews => swigf_TpetraCrsMatrix_supportsRowViews procedure :: getGlobalRowCopy => swigf_TpetraCrsMatrix_getGlobalRowCopy + procedure :: getLocalRowCopy => swigf_TpetraCrsMatrix_getLocalRowCopy procedure :: getGlobalRowView => swigf_TpetraCrsMatrix_getGlobalRowView procedure, private :: apply__SWIG_0 => swigf_TpetraCrsMatrix_apply__SWIG_0 procedure, private :: apply__SWIG_1 => swigf_TpetraCrsMatrix_apply__SWIG_1 @@ -554,11 +566,8 @@ module fortpetra procedure, private :: exportAndFillComplete__SWIG_4 => swigf_TpetraCrsMatrix_exportAndFillComplete__SWIG_4 procedure :: computeGlobalConstants => swigf_TpetraCrsMatrix_computeGlobalConstants procedure :: haveGlobalConstants => swigf_TpetraCrsMatrix_haveGlobalConstants - procedure :: insertLocalValues => swigf_TpetraCrsMatrix_insertLocalValues - procedure :: sumIntoGlobalValues => swigf_TpetraCrsMatrix_sumIntoGlobalValues procedure :: setAllValues => swigf_TpetraCrsMatrix_setAllValues procedure :: getAllValues => swigf_TpetraCrsMatrix_getAllValues - procedure :: getLocalRowCopy => swigf_TpetraCrsMatrix_getLocalRowCopy procedure, private :: doImport__SWIG_0 => swigf_TpetraCrsMatrix_doImport__SWIG_0 procedure, private :: doImport__SWIG_1 => swigf_TpetraCrsMatrix_doImport__SWIG_1 procedure, private :: doExport__SWIG_0 => swigf_TpetraCrsMatrix_doExport__SWIG_0 @@ -570,6 +579,9 @@ module fortpetra generic :: doImport => doImport__SWIG_0, doImport__SWIG_1 generic :: resumeFill => resumeFill__SWIG_0, resumeFill__SWIG_1 generic :: doExport => doExport__SWIG_0, doExport__SWIG_1 + generic :: replaceLocalValues => replaceLocalValues__SWIG_1, replaceLocalValues__SWIG_2 + generic :: sumIntoGlobalValues => sumIntoGlobalValues__SWIG_0 + generic :: sumIntoLocalValues => sumIntoLocalValues__SWIG_0 generic :: fillComplete => fillComplete__SWIG_0, fillComplete__SWIG_1, fillComplete__SWIG_2, fillComplete__SWIG_3 generic :: expertStaticFillComplete => expertStaticFillComplete__SWIG_0, expertStaticFillComplete__SWIG_1, & expertStaticFillComplete__SWIG_2, expertStaticFillComplete__SWIG_3 @@ -709,11 +721,92 @@ subroutine SWIG_free(cptr) & use, intrinsic :: ISO_C_BINDING type(C_PTR), value :: cptr end subroutine -function swigc_new_TpetraMap__SWIG_0() & +function swigc_new_TpetraMap__SWIG_0(farg1, farg3, farg4, farg5) & bind(C, name="_wrap_new_TpetraMap__SWIG_0") & result(fresult) use, intrinsic :: ISO_C_BINDING import :: swigclasswrapper +integer(C_LONG), intent(in) :: farg1 +type(SwigClassWrapper) :: farg3 +integer(C_INT), intent(in) :: farg4 +type(SwigClassWrapper) :: farg5 +type(SwigClassWrapper) :: fresult +end function + +function swigc_new_TpetraMap__SWIG_1(farg1, farg3, farg4) & +bind(C, name="_wrap_new_TpetraMap__SWIG_1") & +result(fresult) +use, intrinsic :: ISO_C_BINDING +import :: swigclasswrapper +integer(C_LONG), intent(in) :: farg1 +type(SwigClassWrapper) :: farg3 +integer(C_INT), intent(in) :: farg4 +type(SwigClassWrapper) :: fresult +end function + +function swigc_new_TpetraMap__SWIG_2(farg1, farg3) & +bind(C, name="_wrap_new_TpetraMap__SWIG_2") & +result(fresult) +use, intrinsic :: ISO_C_BINDING +import :: swigclasswrapper +integer(C_LONG), intent(in) :: farg1 +type(SwigClassWrapper) :: farg3 +type(SwigClassWrapper) :: fresult +end function + +function swigc_new_TpetraMap__SWIG_3(farg1, farg2, farg4, farg5) & +bind(C, name="_wrap_new_TpetraMap__SWIG_3") & +result(fresult) +use, intrinsic :: ISO_C_BINDING +import :: swigclasswrapper +integer(C_LONG), intent(in) :: farg1 +integer(C_INT), intent(in) :: farg2 +type(SwigClassWrapper) :: farg4 +type(SwigClassWrapper) :: farg5 +type(SwigClassWrapper) :: fresult +end function + +function swigc_new_TpetraMap__SWIG_4(farg1, farg2, farg4) & +bind(C, name="_wrap_new_TpetraMap__SWIG_4") & +result(fresult) +use, intrinsic :: ISO_C_BINDING +import :: swigclasswrapper +integer(C_LONG), intent(in) :: farg1 +integer(C_INT), intent(in) :: farg2 +type(SwigClassWrapper) :: farg4 +type(SwigClassWrapper) :: fresult +end function + +function swigc_new_TpetraMap__SWIG_5(farg1, farg2, farg4, farg5) & +bind(C, name="_wrap_new_TpetraMap__SWIG_5") & +result(fresult) +use, intrinsic :: ISO_C_BINDING +import :: swigclasswrapper +import :: swigarraywrapper +integer(C_LONG), intent(in) :: farg1 +type(SwigArrayWrapper) :: farg2 +type(SwigClassWrapper) :: farg4 +type(SwigClassWrapper) :: farg5 +type(SwigClassWrapper) :: fresult +end function + +function swigc_new_TpetraMap__SWIG_6(farg1, farg2, farg4) & +bind(C, name="_wrap_new_TpetraMap__SWIG_6") & +result(fresult) +use, intrinsic :: ISO_C_BINDING +import :: swigclasswrapper +import :: swigarraywrapper +integer(C_LONG), intent(in) :: farg1 +type(SwigArrayWrapper) :: farg2 +type(SwigClassWrapper) :: farg4 +type(SwigClassWrapper) :: fresult +end function + +function swigc_new_TpetraMap__SWIG_7() & +bind(C, name="_wrap_new_TpetraMap__SWIG_7") & +result(fresult) +use, intrinsic :: ISO_C_BINDING +import :: swigclasswrapper type(SwigClassWrapper) :: fresult end function @@ -983,50 +1076,6 @@ function swigc_TpetraMap_replaceCommWithSubset(farg1, farg2) & type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 type(SwigClassWrapper) :: fresult -end function - -function swigc_new_TpetraMap__SWIG_1(farg1, farg2, farg3) & -bind(C, name="_wrap_new_TpetraMap__SWIG_1") & -result(fresult) -use, intrinsic :: ISO_C_BINDING -import :: swigclasswrapper -integer(C_LONG), intent(in) :: farg1 -type(SwigClassWrapper) :: farg2 -integer(C_INT), intent(in) :: farg3 -type(SwigClassWrapper) :: fresult -end function - -function swigc_new_TpetraMap__SWIG_2(farg1, farg2) & -bind(C, name="_wrap_new_TpetraMap__SWIG_2") & -result(fresult) -use, intrinsic :: ISO_C_BINDING -import :: swigclasswrapper -integer(C_LONG), intent(in) :: farg1 -type(SwigClassWrapper) :: farg2 -type(SwigClassWrapper) :: fresult -end function - -function swigc_new_TpetraMap__SWIG_3(farg1, farg2, farg3) & -bind(C, name="_wrap_new_TpetraMap__SWIG_3") & -result(fresult) -use, intrinsic :: ISO_C_BINDING -import :: swigclasswrapper -integer(C_LONG), intent(in) :: farg1 -integer(C_INT), intent(in) :: farg2 -type(SwigClassWrapper) :: farg3 -type(SwigClassWrapper) :: fresult -end function - -function swigc_new_TpetraMap__SWIG_4(farg1, farg2, farg3) & -bind(C, name="_wrap_new_TpetraMap__SWIG_4") & -result(fresult) -use, intrinsic :: ISO_C_BINDING -import :: swigclasswrapper -import :: swigarraywrapper -integer(C_LONG), intent(in) :: farg1 -type(SwigArrayWrapper) :: farg2 -type(SwigClassWrapper) :: farg3 -type(SwigClassWrapper) :: fresult end function subroutine swigc_assignment_TpetraMap(self, other) & @@ -3175,6 +3224,17 @@ subroutine swigc_TpetraCrsMatrix_insertGlobalValues(farg1, farg2, farg3, farg4) type(SwigArrayWrapper) :: farg4 end subroutine +subroutine swigc_TpetraCrsMatrix_insertLocalValues(farg1, farg2, farg3, farg4) & +bind(C, name="_wrap_TpetraCrsMatrix_insertLocalValues") +use, intrinsic :: ISO_C_BINDING +import :: swigclasswrapper +import :: swigarraywrapper +type(SwigClassWrapper) :: farg1 +integer(C_INT), intent(in) :: farg2 +type(SwigArrayWrapper) :: farg3 +type(SwigArrayWrapper) :: farg4 +end subroutine + function swigc_TpetraCrsMatrix_replaceGlobalValues(farg1, farg2, farg3, farg4) & bind(C, name="_wrap_TpetraCrsMatrix_replaceGlobalValues") & result(fresult) @@ -3188,6 +3248,58 @@ function swigc_TpetraCrsMatrix_replaceGlobalValues(farg1, farg2, farg3, farg4) & integer(C_INT) :: fresult end function +function swigc_TpetraCrsMatrix_replaceLocalValues__SWIG_1(farg1, farg2, farg3, farg4) & +bind(C, name="_wrap_TpetraCrsMatrix_replaceLocalValues__SWIG_1") & +result(fresult) +use, intrinsic :: ISO_C_BINDING +import :: swigclasswrapper +import :: swigarraywrapper +type(SwigClassWrapper) :: farg1 +integer(C_INT), intent(in) :: farg2 +type(SwigArrayWrapper) :: farg3 +type(SwigArrayWrapper) :: farg4 +integer(C_INT) :: fresult +end function + +function swigc_TpetraCrsMatrix_replaceLocalValues__SWIG_2(farg1, farg2, farg3, farg4, farg5) & +bind(C, name="_wrap_TpetraCrsMatrix_replaceLocalValues__SWIG_2") & +result(fresult) +use, intrinsic :: ISO_C_BINDING +import :: swigclasswrapper +type(SwigClassWrapper) :: farg1 +integer(C_INT), intent(in) :: farg2 +integer(C_INT), intent(in) :: farg3 +type(C_PTR), value :: farg4 +type(C_PTR), value :: farg5 +integer(C_INT) :: fresult +end function + +function swigc_TpetraCrsMatrix_sumIntoGlobalValues__SWIG_0(farg1, farg2, farg3, farg4) & +bind(C, name="_wrap_TpetraCrsMatrix_sumIntoGlobalValues__SWIG_0") & +result(fresult) +use, intrinsic :: ISO_C_BINDING +import :: swigclasswrapper +import :: swigarraywrapper +type(SwigClassWrapper) :: farg1 +integer(C_LONG_LONG), intent(in) :: farg2 +type(SwigArrayWrapper) :: farg3 +type(SwigArrayWrapper) :: farg4 +integer(C_INT) :: fresult +end function + +function swigc_TpetraCrsMatrix_sumIntoLocalValues__SWIG_0(farg1, farg2, farg3, farg4) & +bind(C, name="_wrap_TpetraCrsMatrix_sumIntoLocalValues__SWIG_0") & +result(fresult) +use, intrinsic :: ISO_C_BINDING +import :: swigclasswrapper +import :: swigarraywrapper +type(SwigClassWrapper) :: farg1 +integer(C_INT), intent(in) :: farg2 +type(SwigArrayWrapper) :: farg3 +type(SwigArrayWrapper) :: farg4 +integer(C_INT) :: fresult +end function + subroutine swigc_TpetraCrsMatrix_setAllToScalar(farg1, farg2) & bind(C, name="_wrap_TpetraCrsMatrix_setAllToScalar") use, intrinsic :: ISO_C_BINDING @@ -3623,6 +3735,18 @@ subroutine swigc_TpetraCrsMatrix_getGlobalRowCopy(farg1, farg2, farg3, farg4, fa type(C_PTR), value :: farg5 end subroutine +subroutine swigc_TpetraCrsMatrix_getLocalRowCopy(farg1, farg2, farg3, farg4, farg5) & +bind(C, name="_wrap_TpetraCrsMatrix_getLocalRowCopy") +use, intrinsic :: ISO_C_BINDING +import :: swigclasswrapper +import :: swigarraywrapper +type(SwigClassWrapper) :: farg1 +integer(C_INT), intent(in) :: farg2 +type(SwigArrayWrapper) :: farg3 +type(SwigArrayWrapper) :: farg4 +type(C_PTR), value :: farg5 +end subroutine + subroutine swigc_TpetraCrsMatrix_getGlobalRowView(farg1, farg2, farg3, farg4) & bind(C, name="_wrap_TpetraCrsMatrix_getGlobalRowView") use, intrinsic :: ISO_C_BINDING @@ -3950,30 +4074,6 @@ function swigc_new_TpetraCrsMatrix__SWIG_17(farg1, farg2, farg3, farg4, farg5) & type(SwigClassWrapper) :: fresult end function -subroutine swigc_TpetraCrsMatrix_insertLocalValues(farg1, farg2, farg3, farg4) & -bind(C, name="_wrap_TpetraCrsMatrix_insertLocalValues") -use, intrinsic :: ISO_C_BINDING -import :: swigclasswrapper -import :: swigarraywrapper -type(SwigClassWrapper) :: farg1 -integer(C_INT), intent(in) :: farg2 -type(SwigArrayWrapper) :: farg3 -type(SwigArrayWrapper) :: farg4 -end subroutine - -function swigc_TpetraCrsMatrix_sumIntoGlobalValues(farg1, farg2, farg3, farg4) & -bind(C, name="_wrap_TpetraCrsMatrix_sumIntoGlobalValues") & -result(fresult) -use, intrinsic :: ISO_C_BINDING -import :: swigclasswrapper -import :: swigarraywrapper -type(SwigClassWrapper) :: farg1 -integer(C_LONG_LONG), intent(in) :: farg2 -type(SwigArrayWrapper) :: farg3 -type(SwigArrayWrapper) :: farg4 -integer(C_INT) :: fresult -end function - subroutine swigc_TpetraCrsMatrix_setAllValues(farg1, farg2, farg3, farg4) & bind(C, name="_wrap_TpetraCrsMatrix_setAllValues") use, intrinsic :: ISO_C_BINDING @@ -3996,18 +4096,6 @@ subroutine swigc_TpetraCrsMatrix_getAllValues(farg1, farg2, farg3, farg4) & type(SwigArrayWrapper) :: farg4 end subroutine -subroutine swigc_TpetraCrsMatrix_getLocalRowCopy(farg1, farg2, farg3, farg4, farg5) & -bind(C, name="_wrap_TpetraCrsMatrix_getLocalRowCopy") -use, intrinsic :: ISO_C_BINDING -import :: swigclasswrapper -import :: swigarraywrapper -type(SwigClassWrapper) :: farg1 -integer(C_INT), intent(in) :: farg2 -type(SwigArrayWrapper) :: farg3 -type(SwigArrayWrapper) :: farg4 -type(C_PTR), value :: farg5 -end subroutine - subroutine swigc_TpetraCrsMatrix_doImport__SWIG_0(farg1, farg2, farg3, farg4) & bind(C, name="_wrap_TpetraCrsMatrix_doImport__SWIG_0") use, intrinsic :: ISO_C_BINDING @@ -4756,14 +4844,170 @@ function combineModeToString(combinemode) & call SWIG_free(fresult%data) end function -function new_TpetraMap__SWIG_0() & +function new_TpetraMap__SWIG_0(numglobalelements, comm, lg, node) & +result(self) +use, intrinsic :: ISO_C_BINDING +type(TpetraMap) :: self +integer(C_LONG), intent(in) :: numglobalelements +class(TeuchosComm), intent(in) :: comm + +integer(TpetraLocalGlobal), intent(in) :: lg +class(SWIGTYPE_Teuchos__RCPT_Kokkos__Compat__KokkosSerialWrapper9ZCDM), intent(in) :: node + +type(SwigClassWrapper) :: fresult +integer(C_LONG) :: farg1 +type(SwigClassWrapper) :: farg3 +integer(C_INT) :: farg4 +type(SwigClassWrapper) :: farg5 + +farg1 = numglobalelements +farg3 = comm%swigdata +farg4 = lg +farg5 = node%swigdata +fresult = swigc_new_TpetraMap__SWIG_0(farg1, farg3, farg4, farg5) +self%swigdata = fresult +end function + +function new_TpetraMap__SWIG_1(numglobalelements, comm, lg) & +result(self) +use, intrinsic :: ISO_C_BINDING +type(TpetraMap) :: self +integer(C_LONG), intent(in) :: numglobalelements +class(TeuchosComm), intent(in) :: comm + +integer(TpetraLocalGlobal), intent(in) :: lg + +type(SwigClassWrapper) :: fresult +integer(C_LONG) :: farg1 +type(SwigClassWrapper) :: farg3 +integer(C_INT) :: farg4 + +farg1 = numglobalelements +farg3 = comm%swigdata +farg4 = lg +fresult = swigc_new_TpetraMap__SWIG_1(farg1, farg3, farg4) +self%swigdata = fresult +end function + +function new_TpetraMap__SWIG_2(numglobalelements, comm) & +result(self) +use, intrinsic :: ISO_C_BINDING +type(TpetraMap) :: self +integer(C_LONG), intent(in) :: numglobalelements +class(TeuchosComm), intent(in) :: comm + +type(SwigClassWrapper) :: fresult +integer(C_LONG) :: farg1 +type(SwigClassWrapper) :: farg3 + +farg1 = numglobalelements +farg3 = comm%swigdata +fresult = swigc_new_TpetraMap__SWIG_2(farg1, farg3) +self%swigdata = fresult +end function + +function new_TpetraMap__SWIG_3(numglobalelements, numlocalelements, comm, node) & result(self) use, intrinsic :: ISO_C_BINDING type(TpetraMap) :: self +integer(C_LONG), intent(in) :: numglobalelements +integer, intent(in) :: numlocalelements +class(TeuchosComm), intent(in) :: comm + +class(SWIGTYPE_Teuchos__RCPT_Kokkos__Compat__KokkosSerialWrapper9ZCDM), intent(in) :: node type(SwigClassWrapper) :: fresult +integer(C_LONG) :: farg1 +integer(C_INT) :: farg2 +type(SwigClassWrapper) :: farg4 +type(SwigClassWrapper) :: farg5 -fresult = swigc_new_TpetraMap__SWIG_0() +farg1 = numglobalelements +farg2 = int(numlocalelements, C_INT) +farg4 = comm%swigdata +farg5 = node%swigdata +fresult = swigc_new_TpetraMap__SWIG_3(farg1, farg2, farg4, farg5) +self%swigdata = fresult +end function + +function new_TpetraMap__SWIG_4(numglobalelements, numlocalelements, comm) & +result(self) +use, intrinsic :: ISO_C_BINDING +type(TpetraMap) :: self +integer(C_LONG), intent(in) :: numglobalelements +integer, intent(in) :: numlocalelements +class(TeuchosComm), intent(in) :: comm + +type(SwigClassWrapper) :: fresult +integer(C_LONG) :: farg1 +integer(C_INT) :: farg2 +type(SwigClassWrapper) :: farg4 + +farg1 = numglobalelements +farg2 = int(numlocalelements, C_INT) +farg4 = comm%swigdata +fresult = swigc_new_TpetraMap__SWIG_4(farg1, farg2, farg4) +self%swigdata = fresult +end function + +function new_TpetraMap__SWIG_5(numglobalelements, indexlist, comm, node) & +result(self) +use, intrinsic :: ISO_C_BINDING +type(TpetraMap) :: self +integer(C_LONG), intent(in) :: numglobalelements +integer(C_LONG_LONG), dimension(:), target :: indexlist +integer(C_LONG_LONG), pointer :: farg2_view +class(TeuchosComm), intent(in) :: comm + +class(SWIGTYPE_Teuchos__RCPT_Kokkos__Compat__KokkosSerialWrapper9ZCDM), intent(in) :: node + +type(SwigClassWrapper) :: fresult +integer(C_LONG) :: farg1 +type(SwigArrayWrapper) :: farg2 +type(SwigClassWrapper) :: farg4 +type(SwigClassWrapper) :: farg5 + +farg1 = numglobalelements +farg2_view => indexlist(1) +farg2%data = c_loc(farg2_view) +farg2%size = size(indexlist) +farg4 = comm%swigdata +farg5 = node%swigdata +fresult = swigc_new_TpetraMap__SWIG_5(farg1, farg2, farg4, farg5) +self%swigdata = fresult +end function + +function new_TpetraMap__SWIG_6(numglobalelements, indexlist, comm) & +result(self) +use, intrinsic :: ISO_C_BINDING +type(TpetraMap) :: self +integer(C_LONG), intent(in) :: numglobalelements +integer(C_LONG_LONG), dimension(:), target :: indexlist +integer(C_LONG_LONG), pointer :: farg2_view +class(TeuchosComm), intent(in) :: comm + +type(SwigClassWrapper) :: fresult +integer(C_LONG) :: farg1 +type(SwigArrayWrapper) :: farg2 +type(SwigClassWrapper) :: farg4 + +farg1 = numglobalelements +farg2_view => indexlist(1) +farg2%data = c_loc(farg2_view) +farg2%size = size(indexlist) +farg4 = comm%swigdata +fresult = swigc_new_TpetraMap__SWIG_6(farg1, farg2, farg4) +self%swigdata = fresult +end function + +function new_TpetraMap__SWIG_7() & +result(self) +use, intrinsic :: ISO_C_BINDING +type(TpetraMap) :: self + +type(SwigClassWrapper) :: fresult + +fresult = swigc_new_TpetraMap__SWIG_7() self%swigdata = fresult end function @@ -5229,97 +5473,16 @@ function swigf_TpetraMap_replaceCommWithSubset(self, newcomm) & type(TpetraMap) :: swig_result class(TpetraMap), intent(in) :: self -class(TeuchosComm), intent(in) :: newcomm - -type(SwigClassWrapper) :: fresult -type(SwigClassWrapper) :: farg1 -type(SwigClassWrapper) :: farg2 - -farg1 = self%swigdata -farg2 = newcomm%swigdata -fresult = swigc_TpetraMap_replaceCommWithSubset(farg1, farg2) -swig_result%swigdata = fresult -end function - -function new_TpetraMap__SWIG_1(numglobalelements, comm, lg) & -result(self) -use, intrinsic :: ISO_C_BINDING -type(TpetraMap) :: self -integer(C_LONG), intent(in) :: numglobalelements -class(TeuchosComm), intent(in) :: comm - -integer(TpetraLocalGlobal), intent(in) :: lg - -type(SwigClassWrapper) :: fresult -integer(C_LONG) :: farg1 -type(SwigClassWrapper) :: farg2 -integer(C_INT) :: farg3 - -farg1 = numglobalelements -farg2 = comm%swigdata -farg3 = lg -fresult = swigc_new_TpetraMap__SWIG_1(farg1, farg2, farg3) -self%swigdata = fresult -end function - -function new_TpetraMap__SWIG_2(numglobalelements, comm) & -result(self) -use, intrinsic :: ISO_C_BINDING -type(TpetraMap) :: self -integer(C_LONG), intent(in) :: numglobalelements -class(TeuchosComm), intent(in) :: comm - -type(SwigClassWrapper) :: fresult -integer(C_LONG) :: farg1 -type(SwigClassWrapper) :: farg2 - -farg1 = numglobalelements -farg2 = comm%swigdata -fresult = swigc_new_TpetraMap__SWIG_2(farg1, farg2) -self%swigdata = fresult -end function - -function new_TpetraMap__SWIG_3(numglobalelements, numlocalelements, comm) & -result(self) -use, intrinsic :: ISO_C_BINDING -type(TpetraMap) :: self -integer(C_LONG), intent(in) :: numglobalelements -integer, intent(in) :: numlocalelements -class(TeuchosComm), intent(in) :: comm - -type(SwigClassWrapper) :: fresult -integer(C_LONG) :: farg1 -integer(C_INT) :: farg2 -type(SwigClassWrapper) :: farg3 - -farg1 = numglobalelements -farg2 = int(numlocalelements, C_INT) -farg3 = comm%swigdata -fresult = swigc_new_TpetraMap__SWIG_3(farg1, farg2, farg3) -self%swigdata = fresult -end function - -function new_TpetraMap__SWIG_4(numglobalelements, indexlist, comm) & -result(self) -use, intrinsic :: ISO_C_BINDING -type(TpetraMap) :: self -integer(C_LONG), intent(in) :: numglobalelements -integer(C_LONG_LONG), dimension(:), target :: indexlist -integer(C_LONG_LONG), pointer :: farg2_view -class(TeuchosComm), intent(in) :: comm +class(TeuchosComm), intent(in) :: newcomm type(SwigClassWrapper) :: fresult -integer(C_LONG) :: farg1 -type(SwigArrayWrapper) :: farg2 -type(SwigClassWrapper) :: farg3 +type(SwigClassWrapper) :: farg1 +type(SwigClassWrapper) :: farg2 -farg1 = numglobalelements -farg2_view => indexlist(1) -farg2%data = c_loc(farg2_view) -farg2%size = size(indexlist) -farg3 = comm%swigdata -fresult = swigc_new_TpetraMap__SWIG_4(farg1, farg2, farg3) -self%swigdata = fresult +farg1 = self%swigdata +farg2 = newcomm%swigdata +fresult = swigc_TpetraMap_replaceCommWithSubset(farg1, farg2) +swig_result%swigdata = fresult end function subroutine swigf_assignment_TpetraMap(self, other) @@ -9353,6 +9516,32 @@ subroutine swigf_TpetraCrsMatrix_insertGlobalValues(self, globalrow, cols, vals) call swigc_TpetraCrsMatrix_insertGlobalValues(farg1, farg2, farg3, farg4) end subroutine +subroutine swigf_TpetraCrsMatrix_insertLocalValues(self, localrow, cols, vals) +use, intrinsic :: ISO_C_BINDING +class(TpetraCrsMatrix), intent(inout) :: self + +integer, intent(in) :: localrow +integer(C_INT), dimension(:), target :: cols +integer(C_INT), pointer :: farg3_view +real(C_DOUBLE), dimension(:), target :: vals +real(C_DOUBLE), pointer :: farg4_view + +type(SwigClassWrapper) :: farg1 +integer(C_INT) :: farg2 +type(SwigArrayWrapper) :: farg3 +type(SwigArrayWrapper) :: farg4 + +farg1 = self%swigdata +farg2 = int(localrow, C_INT) +farg3_view => cols(1) +farg3%data = c_loc(farg3_view) +farg3%size = size(cols) +farg4_view => vals(1) +farg4%data = c_loc(farg4_view) +farg4%size = size(vals) +call swigc_TpetraCrsMatrix_insertLocalValues(farg1, farg2, farg3, farg4) +end subroutine + function swigf_TpetraCrsMatrix_replaceGlobalValues(self, globalrow, cols, vals) & result(swig_result) use, intrinsic :: ISO_C_BINDING @@ -9383,6 +9572,123 @@ function swigf_TpetraCrsMatrix_replaceGlobalValues(self, globalrow, cols, vals) swig_result = int(fresult) end function +function swigf_TpetraCrsMatrix_replaceLocalValues__SWIG_1(self, localrow, cols, vals) & +result(swig_result) +use, intrinsic :: ISO_C_BINDING +integer :: swig_result +class(TpetraCrsMatrix), intent(in) :: self + +integer, intent(in) :: localrow +integer(C_INT), dimension(:), target :: cols +integer(C_INT), pointer :: farg3_view +real(C_DOUBLE), dimension(:), target :: vals +real(C_DOUBLE), pointer :: farg4_view + +integer(C_INT) :: fresult +type(SwigClassWrapper) :: farg1 +integer(C_INT) :: farg2 +type(SwigArrayWrapper) :: farg3 +type(SwigArrayWrapper) :: farg4 + +farg1 = self%swigdata +farg2 = int(localrow, C_INT) +farg3_view => cols(1) +farg3%data = c_loc(farg3_view) +farg3%size = size(cols) +farg4_view => vals(1) +farg4%data = c_loc(farg4_view) +farg4%size = size(vals) +fresult = swigc_TpetraCrsMatrix_replaceLocalValues__SWIG_1(farg1, farg2, farg3, farg4) +swig_result = int(fresult) +end function + +function swigf_TpetraCrsMatrix_replaceLocalValues__SWIG_2(self, localrow, nument, inputvals, inputcols) & +result(swig_result) +use, intrinsic :: ISO_C_BINDING +integer :: swig_result +class(TpetraCrsMatrix), intent(in) :: self + +integer, intent(in) :: localrow +integer, intent(in) :: nument +real(C_DOUBLE), dimension(*), target, intent(in) :: inputvals +integer, dimension(*), target, intent(in) :: inputcols + +integer(C_INT) :: fresult +type(SwigClassWrapper) :: farg1 +integer(C_INT) :: farg2 +integer(C_INT) :: farg3 +type(C_PTR) :: farg4 +type(C_PTR) :: farg5 + +farg1 = self%swigdata +farg2 = int(localrow, C_INT) +farg3 = int(nument, C_INT) +farg4 = c_loc(inputvals(1)) +farg5 = c_loc(inputcols(1)) +fresult = swigc_TpetraCrsMatrix_replaceLocalValues__SWIG_2(farg1, farg2, farg3, farg4, farg5) +swig_result = int(fresult) +end function + +function swigf_TpetraCrsMatrix_sumIntoGlobalValues__SWIG_0(self, globalrow, cols, vals) & +result(swig_result) +use, intrinsic :: ISO_C_BINDING +integer :: swig_result +class(TpetraCrsMatrix), intent(inout) :: self + +integer(C_LONG_LONG), intent(in) :: globalrow +integer(C_LONG_LONG), dimension(:), target :: cols +integer(C_LONG_LONG), pointer :: farg3_view +real(C_DOUBLE), dimension(:), target :: vals +real(C_DOUBLE), pointer :: farg4_view + +integer(C_INT) :: fresult +type(SwigClassWrapper) :: farg1 +integer(C_LONG_LONG) :: farg2 +type(SwigArrayWrapper) :: farg3 +type(SwigArrayWrapper) :: farg4 + +farg1 = self%swigdata +farg2 = globalrow +farg3_view => cols(1) +farg3%data = c_loc(farg3_view) +farg3%size = size(cols) +farg4_view => vals(1) +farg4%data = c_loc(farg4_view) +farg4%size = size(vals) +fresult = swigc_TpetraCrsMatrix_sumIntoGlobalValues__SWIG_0(farg1, farg2, farg3, farg4) +swig_result = int(fresult) +end function + +function swigf_TpetraCrsMatrix_sumIntoLocalValues__SWIG_0(self, localrow, cols, vals) & +result(swig_result) +use, intrinsic :: ISO_C_BINDING +integer :: swig_result +class(TpetraCrsMatrix), intent(in) :: self + +integer, intent(in) :: localrow +integer(C_INT), dimension(:), target :: cols +integer(C_INT), pointer :: farg3_view +real(C_DOUBLE), dimension(:), target :: vals +real(C_DOUBLE), pointer :: farg4_view + +integer(C_INT) :: fresult +type(SwigClassWrapper) :: farg1 +integer(C_INT) :: farg2 +type(SwigArrayWrapper) :: farg3 +type(SwigArrayWrapper) :: farg4 + +farg1 = self%swigdata +farg2 = int(localrow, C_INT) +farg3_view => cols(1) +farg3%data = c_loc(farg3_view) +farg3%size = size(cols) +farg4_view => vals(1) +farg4%data = c_loc(farg4_view) +farg4%size = size(vals) +fresult = swigc_TpetraCrsMatrix_sumIntoLocalValues__SWIG_0(farg1, farg2, farg3, farg4) +swig_result = int(fresult) +end function + subroutine swigf_TpetraCrsMatrix_setAllToScalar(self, alpha) use, intrinsic :: ISO_C_BINDING class(TpetraCrsMatrix), intent(inout) :: self @@ -10146,6 +10452,35 @@ subroutine swigf_TpetraCrsMatrix_getGlobalRowCopy(self, globalrow, indices, valu call swigc_TpetraCrsMatrix_getGlobalRowCopy(farg1, farg2, farg3, farg4, farg5) end subroutine +subroutine swigf_TpetraCrsMatrix_getLocalRowCopy(self, localrow, colinds, vals, numentries) +use, intrinsic :: ISO_C_BINDING +class(TpetraCrsMatrix), intent(in) :: self + +integer, intent(in) :: localrow +integer(C_INT), dimension(:), target :: colinds +integer(C_INT), pointer :: farg3_view +real(C_DOUBLE), dimension(:), target :: vals +real(C_DOUBLE), pointer :: farg4_view +integer(C_SIZE_T), target, intent(inout) :: numentries + +type(SwigClassWrapper) :: farg1 +integer(C_INT) :: farg2 +type(SwigArrayWrapper) :: farg3 +type(SwigArrayWrapper) :: farg4 +type(C_PTR) :: farg5 + +farg1 = self%swigdata +farg2 = int(localrow, C_INT) +farg3_view => colinds(1) +farg3%data = c_loc(farg3_view) +farg3%size = size(colinds) +farg4_view => vals(1) +farg4%data = c_loc(farg4_view) +farg4%size = size(vals) +farg5 = c_loc(numentries) +call swigc_TpetraCrsMatrix_getLocalRowCopy(farg1, farg2, farg3, farg4, farg5) +end subroutine + subroutine swigf_TpetraCrsMatrix_getGlobalRowView(self, globalrow, indices, values) use, intrinsic :: ISO_C_BINDING class(TpetraCrsMatrix), intent(in) :: self @@ -10863,62 +11198,6 @@ function new_TpetraCrsMatrix__SWIG_17(rowmap, colmap, rowpointers, columnindices self%swigdata = fresult end function -subroutine swigf_TpetraCrsMatrix_insertLocalValues(self, localrow, cols, vals) -use, intrinsic :: ISO_C_BINDING -class(TpetraCrsMatrix), intent(inout) :: self - -integer, intent(in) :: localrow -integer(C_INT), dimension(:), target :: cols -integer(C_INT), pointer :: farg3_view -real(C_DOUBLE), dimension(:), target :: vals -real(C_DOUBLE), pointer :: farg4_view - -type(SwigClassWrapper) :: farg1 -integer(C_INT) :: farg2 -type(SwigArrayWrapper) :: farg3 -type(SwigArrayWrapper) :: farg4 - -farg1 = self%swigdata -farg2 = int(localrow, C_INT) -farg3_view => cols(1) -farg3%data = c_loc(farg3_view) -farg3%size = size(cols) -farg4_view => vals(1) -farg4%data = c_loc(farg4_view) -farg4%size = size(vals) -call swigc_TpetraCrsMatrix_insertLocalValues(farg1, farg2, farg3, farg4) -end subroutine - -function swigf_TpetraCrsMatrix_sumIntoGlobalValues(self, globalrow, cols, vals) & -result(swig_result) -use, intrinsic :: ISO_C_BINDING -integer :: swig_result -class(TpetraCrsMatrix), intent(inout) :: self - -integer(C_LONG_LONG), intent(in) :: globalrow -integer(C_LONG_LONG), dimension(:), target :: cols -integer(C_LONG_LONG), pointer :: farg3_view -real(C_DOUBLE), dimension(:), target :: vals -real(C_DOUBLE), pointer :: farg4_view - -integer(C_INT) :: fresult -type(SwigClassWrapper) :: farg1 -integer(C_LONG_LONG) :: farg2 -type(SwigArrayWrapper) :: farg3 -type(SwigArrayWrapper) :: farg4 - -farg1 = self%swigdata -farg2 = globalrow -farg3_view => cols(1) -farg3%data = c_loc(farg3_view) -farg3%size = size(cols) -farg4_view => vals(1) -farg4%data = c_loc(farg4_view) -farg4%size = size(vals) -fresult = swigc_TpetraCrsMatrix_sumIntoGlobalValues(farg1, farg2, farg3, farg4) -swig_result = int(fresult) -end function - subroutine swigf_TpetraCrsMatrix_setAllValues(self, ptr, ind, val) use, intrinsic :: ISO_C_BINDING class(TpetraCrsMatrix), intent(inout) :: self @@ -10977,35 +11256,6 @@ subroutine swigf_TpetraCrsMatrix_getAllValues(self, rowpointers, columnindices, call swigc_TpetraCrsMatrix_getAllValues(farg1, farg2, farg3, farg4) end subroutine -subroutine swigf_TpetraCrsMatrix_getLocalRowCopy(self, localrow, colinds, vals, numindices) -use, intrinsic :: ISO_C_BINDING -class(TpetraCrsMatrix), intent(in) :: self - -integer, intent(in) :: localrow -integer(C_INT), dimension(:), target :: colinds -integer(C_INT), pointer :: farg3_view -real(C_DOUBLE), dimension(:), target :: vals -real(C_DOUBLE), pointer :: farg4_view -integer(C_SIZE_T), target, intent(inout) :: numindices - -type(SwigClassWrapper) :: farg1 -integer(C_INT) :: farg2 -type(SwigArrayWrapper) :: farg3 -type(SwigArrayWrapper) :: farg4 -type(C_PTR) :: farg5 - -farg1 = self%swigdata -farg2 = int(localrow, C_INT) -farg3_view => colinds(1) -farg3%data = c_loc(farg3_view) -farg3%size = size(colinds) -farg4_view => vals(1) -farg4%data = c_loc(farg4_view) -farg4%size = size(vals) -farg5 = c_loc(numindices) -call swigc_TpetraCrsMatrix_getLocalRowCopy(farg1, farg2, farg3, farg4, farg5) -end subroutine - subroutine swigf_TpetraCrsMatrix_doImport__SWIG_0(self, source, importer, cm) use, intrinsic :: ISO_C_BINDING class(TpetraCrsMatrix), intent(inout) :: self diff --git a/src/tpetra/src/swig/fortpetraFORTRAN_wrap.cxx b/src/tpetra/src/swig/fortpetraFORTRAN_wrap.cxx index 14c08d96..56b8204d 100644 --- a/src/tpetra/src/swig/fortpetraFORTRAN_wrap.cxx +++ b/src/tpetra/src/swig/fortpetraFORTRAN_wrap.cxx @@ -213,6 +213,14 @@ void SWIG_store_exception(const char* decl, int errcode, const char *msg); } +#define SWIG_check_nonnull(SWIG_CLASS_WRAPPER, TYPENAME, FNAME, FUNCNAME, RETURNNULL) \ + if ((SWIG_CLASS_WRAPPER).mem == SWIG_NULL) { \ + SWIG_exception_impl(FUNCNAME, SWIG_TypeError, \ + "Cannot pass null " TYPENAME " (class " FNAME ") " \ + "as a reference", RETURNNULL); \ + } + + namespace swig { enum AssignmentFlags { @@ -232,14 +240,6 @@ struct assignment_flags; SWIG_assign_impl::value >(LEFT, RIGHT); -#define SWIG_check_nonnull(SWIG_CLASS_WRAPPER, TYPENAME, FNAME, FUNCNAME, RETURNNULL) \ - if ((SWIG_CLASS_WRAPPER).mem == SWIG_NULL) { \ - SWIG_exception_impl(FUNCNAME, SWIG_TypeError, \ - "Cannot pass null " TYPENAME " (class " FNAME ") " \ - "as a reference", RETURNNULL); \ - } - - #define SWIG_check_mutable(SWIG_CLASS_WRAPPER, TYPENAME, FNAME, FUNCNAME, RETURNNULL) \ if ((SWIG_CLASS_WRAPPER).mem == SWIG_CREF) { \ SWIG_exception_impl(FUNCNAME, SWIG_TypeError, \ @@ -350,15 +350,6 @@ SWIGINTERN SwigArrayWrapper SwigArrayWrapper_uninitialized() { #define SWIG_NO_NULL_DELETER_SWIG_POINTER_NEW #define SWIG_NO_NULL_DELETER_SWIG_POINTER_OWN -SWIGINTERN Tpetra::Map< LO,GO,NO > *new_Tpetra_Map_Sl_LO_Sc_GO_Sc_NO_Sg___SWIG_1(Tpetra::global_size_t numGlobalElements,Teuchos::RCP< Teuchos::Comm< int > const > const &comm,Tpetra::LocalGlobal lg=Tpetra::GloballyDistributed){ - return new Tpetra::Map(numGlobalElements, 1/*indexBase*/, comm, lg); - } -SWIGINTERN Tpetra::Map< LO,GO,NO > *new_Tpetra_Map_Sl_LO_Sc_GO_Sc_NO_Sg___SWIG_3(Tpetra::global_size_t numGlobalElements,size_t numLocalElements,Teuchos::RCP< Teuchos::Comm< int > const > const &comm){ - return new Tpetra::Map(numGlobalElements, numLocalElements, 1/*indexBase*/, comm); - } -SWIGINTERN Tpetra::Map< LO,GO,NO > *new_Tpetra_Map_Sl_LO_Sc_GO_Sc_NO_Sg___SWIG_4(Tpetra::global_size_t const numGlobalElements,Teuchos::ArrayView< GO const > indexList,Teuchos::RCP< Teuchos::Comm< int > const > const &comm){ - return new Tpetra::Map(numGlobalElements, indexList, 1/*indexBase*/, comm); - } #include @@ -787,16 +778,6 @@ SWIGINTERN Tpetra::CrsMatrix< SC,LO,GO,NO > *new_Tpetra_CrsMatrix_Sl_SC_Sc_LO_Sc columnIndicesArrayRCP[i] = columnIndices[i]-1; return new Tpetra::CrsMatrix(rowMap, colMap, rowPointersArrayRCP, columnIndicesArrayRCP, arcpFromArrayView(values), params); } -SWIGINTERN void Tpetra_CrsMatrix_Sl_SC_Sc_LO_Sc_GO_Sc_NO_Sg__insertLocalValues(Tpetra::CrsMatrix< SC,LO,GO,NO > *self,LO const localRow,Teuchos::ArrayView< LO const > cols,Teuchos::ArrayView< SC const > vals){ - Teuchos::Array colsArray(cols.size()); - for (int i = 0; i < colsArray.size(); i++) - colsArray[i] = cols[i] - 1; - Teuchos::ArrayView valsView = Teuchos::arrayView(vals.getRawPtr(), vals.size()); - self->insertLocalValues(localRow, colsArray, valsView); - } -SWIGINTERN LO Tpetra_CrsMatrix_Sl_SC_Sc_LO_Sc_GO_Sc_NO_Sg__sumIntoGlobalValues(Tpetra::CrsMatrix< SC,LO,GO,NO > *self,GO const globalRow,Teuchos::ArrayView< GO const > cols,Teuchos::ArrayView< SC const > vals){ - return self->sumIntoGlobalValues(globalRow, cols, vals, false); // TODO: for now, we only run in serial, no atomics necessary - } SWIGINTERN void Tpetra_CrsMatrix_Sl_SC_Sc_LO_Sc_GO_Sc_NO_Sg__setAllValues(Tpetra::CrsMatrix< SC,LO,GO,NO > *self,Teuchos::ArrayView< std::size_t > ptr,Teuchos::ArrayView< LO > ind,Teuchos::ArrayView< SC > val){ Teuchos::ArrayRCP ptrArrayRCP(ptr.size()); for (int i = 0; i < ptrArrayRCP.size(); i++) @@ -824,12 +805,6 @@ SWIGINTERN void Tpetra_CrsMatrix_Sl_SC_Sc_LO_Sc_GO_Sc_NO_Sg__getAllValues(Tpetra values [i] = valuesArrayRCP[i]; } } -SWIGINTERN void Tpetra_CrsMatrix_Sl_SC_Sc_LO_Sc_GO_Sc_NO_Sg__getLocalRowCopy(Tpetra::CrsMatrix< SC,LO,GO,NO > const *self,LO localRow,Teuchos::ArrayView< LO > colInds,Teuchos::ArrayView< SC > vals,size_t &NumIndices){ - self->getLocalRowCopy(localRow, colInds, vals, NumIndices); - - for (int i = 0; i < colInds.size(); i++) - colInds[i]++; - } SWIGINTERN void Tpetra_CrsMatrix_Sl_SC_Sc_LO_Sc_GO_Sc_NO_Sg__doImport__SWIG_0(Tpetra::CrsMatrix< SC,LO,GO,NO > *self,Tpetra::CrsMatrix< SC,LO,GO,NO > const &source,Tpetra::Import< LO,GO,NO > const &importer,Tpetra::CombineMode CM){ self->doImport(source, importer, CM); } @@ -996,7 +971,326 @@ SWIGEXPORT SwigArrayWrapper _wrap_combineModeToString(int const *farg1) { } -SWIGEXPORT SwigClassWrapper _wrap_new_TpetraMap__SWIG_0() { +SWIGEXPORT SwigClassWrapper _wrap_new_TpetraMap__SWIG_0(long const *farg1, SwigClassWrapper const *farg3, int const *farg4, SwigClassWrapper const *farg5) { + SwigClassWrapper fresult ; + Tpetra::global_size_t arg1 ; + long long arg2 ; + Teuchos::RCP< Teuchos::Comm< int > const > *arg3 = 0 ; + Tpetra::LocalGlobal arg4 ; + Teuchos::RCP< Kokkos::Compat::KokkosSerialWrapperNode > *arg5 = 0 ; + Teuchos::RCP< Teuchos::Comm< int > const > tempnull3 ; + Tpetra::Map< LO,GO,NO > *result = 0 ; + + { + arg2 = 1; + } + arg1 = static_cast< Tpetra::global_size_t >(*farg1); + arg3 = farg3->cptr ? static_cast< Teuchos::RCP< Teuchos::Comm< int > const > * >(farg3->cptr) : &tempnull3; + arg4 = static_cast< Tpetra::LocalGlobal >(*farg4); + SWIG_check_nonnull(*farg5, "Teuchos::RCP< Kokkos::Compat::KokkosSerialWrapperNode > const &", "SWIGTYPE_Teuchos__RCPT_Kokkos__Compat__KokkosSerialWrapper9ZCDM", "Tpetra::Map< LO,GO,NO >::Map(Tpetra::global_size_t,long long,Teuchos::RCP< Teuchos::Comm< int > const > const &,Tpetra::LocalGlobal,Teuchos::RCP< Kokkos::Compat::KokkosSerialWrapperNode > const &)", return SwigClassWrapper_uninitialized()); + arg5 = static_cast< Teuchos::RCP< Kokkos::Compat::KokkosSerialWrapperNode > * >(farg5->cptr); + { + // Make sure no unhandled exceptions exist before performing a new action + SWIG_check_unhandled_exception_impl("Tpetra::Map< LO,GO,NO >::Map(Tpetra::global_size_t,long long,Teuchos::RCP< Teuchos::Comm< int > const > const &,Tpetra::LocalGlobal,Teuchos::RCP< Kokkos::Compat::KokkosSerialWrapperNode > const &)");; + try + { + // Attempt the wrapped function call + result = (Tpetra::Map< LO,GO,NO > *)new Tpetra::Map< LO,GO,NO >(arg1,arg2,(Teuchos::RCP< Teuchos::Comm< int > const > const &)*arg3,arg4,(Teuchos::RCP< Kokkos::Compat::KokkosSerialWrapperNode > const &)*arg5); + } + catch (const std::range_error& e) + { + // Store a C++ exception + SWIG_exception_impl("Tpetra::Map< LO,GO,NO >::Map(Tpetra::global_size_t,long long,Teuchos::RCP< Teuchos::Comm< int > const > const &,Tpetra::LocalGlobal,Teuchos::RCP< Kokkos::Compat::KokkosSerialWrapperNode > const &)", SWIG_IndexError, e.what(), return SwigClassWrapper_uninitialized()); + } + catch (const std::exception& e) + { + // Store a C++ exception + SWIG_exception_impl("Tpetra::Map< LO,GO,NO >::Map(Tpetra::global_size_t,long long,Teuchos::RCP< Teuchos::Comm< int > const > const &,Tpetra::LocalGlobal,Teuchos::RCP< Kokkos::Compat::KokkosSerialWrapperNode > const &)", SWIG_RuntimeError, e.what(), return SwigClassWrapper_uninitialized()); + } + catch (...) + { + SWIG_exception_impl("Tpetra::Map< LO,GO,NO >::Map(Tpetra::global_size_t,long long,Teuchos::RCP< Teuchos::Comm< int > const > const &,Tpetra::LocalGlobal,Teuchos::RCP< Kokkos::Compat::KokkosSerialWrapperNode > const &)", SWIG_UnknownError, "An unknown exception occurred", return SwigClassWrapper_uninitialized()); + } + } + fresult.cptr = result ? new Teuchos::RCP< Tpetra::Map >(result SWIG_NO_NULL_DELETER_1) : NULL; + fresult.mem = SWIG_MOVE; + return fresult; +} + + +SWIGEXPORT SwigClassWrapper _wrap_new_TpetraMap__SWIG_1(long const *farg1, SwigClassWrapper const *farg3, int const *farg4) { + SwigClassWrapper fresult ; + Tpetra::global_size_t arg1 ; + long long arg2 ; + Teuchos::RCP< Teuchos::Comm< int > const > *arg3 = 0 ; + Tpetra::LocalGlobal arg4 ; + Teuchos::RCP< Teuchos::Comm< int > const > tempnull3 ; + Tpetra::Map< LO,GO,NO > *result = 0 ; + + { + arg2 = 1; + } + arg1 = static_cast< Tpetra::global_size_t >(*farg1); + arg3 = farg3->cptr ? static_cast< Teuchos::RCP< Teuchos::Comm< int > const > * >(farg3->cptr) : &tempnull3; + arg4 = static_cast< Tpetra::LocalGlobal >(*farg4); + { + // Make sure no unhandled exceptions exist before performing a new action + SWIG_check_unhandled_exception_impl("Tpetra::Map< LO,GO,NO >::Map(Tpetra::global_size_t,long long,Teuchos::RCP< Teuchos::Comm< int > const > const &,Tpetra::LocalGlobal)");; + try + { + // Attempt the wrapped function call + result = (Tpetra::Map< LO,GO,NO > *)new Tpetra::Map< LO,GO,NO >(arg1,arg2,(Teuchos::RCP< Teuchos::Comm< int > const > const &)*arg3,arg4); + } + catch (const std::range_error& e) + { + // Store a C++ exception + SWIG_exception_impl("Tpetra::Map< LO,GO,NO >::Map(Tpetra::global_size_t,long long,Teuchos::RCP< Teuchos::Comm< int > const > const &,Tpetra::LocalGlobal)", SWIG_IndexError, e.what(), return SwigClassWrapper_uninitialized()); + } + catch (const std::exception& e) + { + // Store a C++ exception + SWIG_exception_impl("Tpetra::Map< LO,GO,NO >::Map(Tpetra::global_size_t,long long,Teuchos::RCP< Teuchos::Comm< int > const > const &,Tpetra::LocalGlobal)", SWIG_RuntimeError, e.what(), return SwigClassWrapper_uninitialized()); + } + catch (...) + { + SWIG_exception_impl("Tpetra::Map< LO,GO,NO >::Map(Tpetra::global_size_t,long long,Teuchos::RCP< Teuchos::Comm< int > const > const &,Tpetra::LocalGlobal)", SWIG_UnknownError, "An unknown exception occurred", return SwigClassWrapper_uninitialized()); + } + } + fresult.cptr = result ? new Teuchos::RCP< Tpetra::Map >(result SWIG_NO_NULL_DELETER_1) : NULL; + fresult.mem = SWIG_MOVE; + return fresult; +} + + +SWIGEXPORT SwigClassWrapper _wrap_new_TpetraMap__SWIG_2(long const *farg1, SwigClassWrapper const *farg3) { + SwigClassWrapper fresult ; + Tpetra::global_size_t arg1 ; + long long arg2 ; + Teuchos::RCP< Teuchos::Comm< int > const > *arg3 = 0 ; + Teuchos::RCP< Teuchos::Comm< int > const > tempnull3 ; + Tpetra::Map< LO,GO,NO > *result = 0 ; + + { + arg2 = 1; + } + arg1 = static_cast< Tpetra::global_size_t >(*farg1); + arg3 = farg3->cptr ? static_cast< Teuchos::RCP< Teuchos::Comm< int > const > * >(farg3->cptr) : &tempnull3; + { + // Make sure no unhandled exceptions exist before performing a new action + SWIG_check_unhandled_exception_impl("Tpetra::Map< LO,GO,NO >::Map(Tpetra::global_size_t,long long,Teuchos::RCP< Teuchos::Comm< int > const > const &)");; + try + { + // Attempt the wrapped function call + result = (Tpetra::Map< LO,GO,NO > *)new Tpetra::Map< LO,GO,NO >(arg1,arg2,(Teuchos::RCP< Teuchos::Comm< int > const > const &)*arg3); + } + catch (const std::range_error& e) + { + // Store a C++ exception + SWIG_exception_impl("Tpetra::Map< LO,GO,NO >::Map(Tpetra::global_size_t,long long,Teuchos::RCP< Teuchos::Comm< int > const > const &)", SWIG_IndexError, e.what(), return SwigClassWrapper_uninitialized()); + } + catch (const std::exception& e) + { + // Store a C++ exception + SWIG_exception_impl("Tpetra::Map< LO,GO,NO >::Map(Tpetra::global_size_t,long long,Teuchos::RCP< Teuchos::Comm< int > const > const &)", SWIG_RuntimeError, e.what(), return SwigClassWrapper_uninitialized()); + } + catch (...) + { + SWIG_exception_impl("Tpetra::Map< LO,GO,NO >::Map(Tpetra::global_size_t,long long,Teuchos::RCP< Teuchos::Comm< int > const > const &)", SWIG_UnknownError, "An unknown exception occurred", return SwigClassWrapper_uninitialized()); + } + } + fresult.cptr = result ? new Teuchos::RCP< Tpetra::Map >(result SWIG_NO_NULL_DELETER_1) : NULL; + fresult.mem = SWIG_MOVE; + return fresult; +} + + +SWIGEXPORT SwigClassWrapper _wrap_new_TpetraMap__SWIG_3(long const *farg1, int const *farg2, SwigClassWrapper const *farg4, SwigClassWrapper const *farg5) { + SwigClassWrapper fresult ; + Tpetra::global_size_t arg1 ; + size_t arg2 ; + long long arg3 ; + Teuchos::RCP< Teuchos::Comm< int > const > *arg4 = 0 ; + Teuchos::RCP< Kokkos::Compat::KokkosSerialWrapperNode > *arg5 = 0 ; + Teuchos::RCP< Teuchos::Comm< int > const > tempnull4 ; + Tpetra::Map< LO,GO,NO > *result = 0 ; + + { + arg3 = 1; + } + arg1 = static_cast< Tpetra::global_size_t >(*farg1); + arg2 = static_cast< size_t >(*farg2); + arg4 = farg4->cptr ? static_cast< Teuchos::RCP< Teuchos::Comm< int > const > * >(farg4->cptr) : &tempnull4; + SWIG_check_nonnull(*farg5, "Teuchos::RCP< Kokkos::Compat::KokkosSerialWrapperNode > const &", "SWIGTYPE_Teuchos__RCPT_Kokkos__Compat__KokkosSerialWrapper9ZCDM", "Tpetra::Map< LO,GO,NO >::Map(Tpetra::global_size_t,size_t,long long,Teuchos::RCP< Teuchos::Comm< int > const > const &,Teuchos::RCP< Kokkos::Compat::KokkosSerialWrapperNode > const &)", return SwigClassWrapper_uninitialized()); + arg5 = static_cast< Teuchos::RCP< Kokkos::Compat::KokkosSerialWrapperNode > * >(farg5->cptr); + { + // Make sure no unhandled exceptions exist before performing a new action + SWIG_check_unhandled_exception_impl("Tpetra::Map< LO,GO,NO >::Map(Tpetra::global_size_t,size_t,long long,Teuchos::RCP< Teuchos::Comm< int > const > const &,Teuchos::RCP< Kokkos::Compat::KokkosSerialWrapperNode > const &)");; + try + { + // Attempt the wrapped function call + result = (Tpetra::Map< LO,GO,NO > *)new Tpetra::Map< LO,GO,NO >(arg1,arg2,arg3,(Teuchos::RCP< Teuchos::Comm< int > const > const &)*arg4,(Teuchos::RCP< Kokkos::Compat::KokkosSerialWrapperNode > const &)*arg5); + } + catch (const std::range_error& e) + { + // Store a C++ exception + SWIG_exception_impl("Tpetra::Map< LO,GO,NO >::Map(Tpetra::global_size_t,size_t,long long,Teuchos::RCP< Teuchos::Comm< int > const > const &,Teuchos::RCP< Kokkos::Compat::KokkosSerialWrapperNode > const &)", SWIG_IndexError, e.what(), return SwigClassWrapper_uninitialized()); + } + catch (const std::exception& e) + { + // Store a C++ exception + SWIG_exception_impl("Tpetra::Map< LO,GO,NO >::Map(Tpetra::global_size_t,size_t,long long,Teuchos::RCP< Teuchos::Comm< int > const > const &,Teuchos::RCP< Kokkos::Compat::KokkosSerialWrapperNode > const &)", SWIG_RuntimeError, e.what(), return SwigClassWrapper_uninitialized()); + } + catch (...) + { + SWIG_exception_impl("Tpetra::Map< LO,GO,NO >::Map(Tpetra::global_size_t,size_t,long long,Teuchos::RCP< Teuchos::Comm< int > const > const &,Teuchos::RCP< Kokkos::Compat::KokkosSerialWrapperNode > const &)", SWIG_UnknownError, "An unknown exception occurred", return SwigClassWrapper_uninitialized()); + } + } + fresult.cptr = result ? new Teuchos::RCP< Tpetra::Map >(result SWIG_NO_NULL_DELETER_1) : NULL; + fresult.mem = SWIG_MOVE; + return fresult; +} + + +SWIGEXPORT SwigClassWrapper _wrap_new_TpetraMap__SWIG_4(long const *farg1, int const *farg2, SwigClassWrapper const *farg4) { + SwigClassWrapper fresult ; + Tpetra::global_size_t arg1 ; + size_t arg2 ; + long long arg3 ; + Teuchos::RCP< Teuchos::Comm< int > const > *arg4 = 0 ; + Teuchos::RCP< Teuchos::Comm< int > const > tempnull4 ; + Tpetra::Map< LO,GO,NO > *result = 0 ; + + { + arg3 = 1; + } + arg1 = static_cast< Tpetra::global_size_t >(*farg1); + arg2 = static_cast< size_t >(*farg2); + arg4 = farg4->cptr ? static_cast< Teuchos::RCP< Teuchos::Comm< int > const > * >(farg4->cptr) : &tempnull4; + { + // Make sure no unhandled exceptions exist before performing a new action + SWIG_check_unhandled_exception_impl("Tpetra::Map< LO,GO,NO >::Map(Tpetra::global_size_t,size_t,long long,Teuchos::RCP< Teuchos::Comm< int > const > const &)");; + try + { + // Attempt the wrapped function call + result = (Tpetra::Map< LO,GO,NO > *)new Tpetra::Map< LO,GO,NO >(arg1,arg2,arg3,(Teuchos::RCP< Teuchos::Comm< int > const > const &)*arg4); + } + catch (const std::range_error& e) + { + // Store a C++ exception + SWIG_exception_impl("Tpetra::Map< LO,GO,NO >::Map(Tpetra::global_size_t,size_t,long long,Teuchos::RCP< Teuchos::Comm< int > const > const &)", SWIG_IndexError, e.what(), return SwigClassWrapper_uninitialized()); + } + catch (const std::exception& e) + { + // Store a C++ exception + SWIG_exception_impl("Tpetra::Map< LO,GO,NO >::Map(Tpetra::global_size_t,size_t,long long,Teuchos::RCP< Teuchos::Comm< int > const > const &)", SWIG_RuntimeError, e.what(), return SwigClassWrapper_uninitialized()); + } + catch (...) + { + SWIG_exception_impl("Tpetra::Map< LO,GO,NO >::Map(Tpetra::global_size_t,size_t,long long,Teuchos::RCP< Teuchos::Comm< int > const > const &)", SWIG_UnknownError, "An unknown exception occurred", return SwigClassWrapper_uninitialized()); + } + } + fresult.cptr = result ? new Teuchos::RCP< Tpetra::Map >(result SWIG_NO_NULL_DELETER_1) : NULL; + fresult.mem = SWIG_MOVE; + return fresult; +} + + +SWIGEXPORT SwigClassWrapper _wrap_new_TpetraMap__SWIG_5(long const *farg1, SwigArrayWrapper *farg2, SwigClassWrapper const *farg4, SwigClassWrapper const *farg5) { + SwigClassWrapper fresult ; + Tpetra::global_size_t arg1 ; + Teuchos::ArrayView< long long const > *arg2 = 0 ; + long long arg3 ; + Teuchos::RCP< Teuchos::Comm< int > const > *arg4 = 0 ; + Teuchos::RCP< Kokkos::Compat::KokkosSerialWrapperNode > *arg5 = 0 ; + Teuchos::ArrayView< long long const > tmparr2 ; + Teuchos::RCP< Teuchos::Comm< int > const > tempnull4 ; + Tpetra::Map< LO,GO,NO > *result = 0 ; + + { + arg3 = 1; + } + arg1 = static_cast< Tpetra::global_size_t >(*farg1); + tmparr2 = Teuchos::ArrayView(static_cast(farg2->data), farg2->size); + arg2 = &tmparr2; + arg4 = farg4->cptr ? static_cast< Teuchos::RCP< Teuchos::Comm< int > const > * >(farg4->cptr) : &tempnull4; + SWIG_check_nonnull(*farg5, "Teuchos::RCP< Kokkos::Compat::KokkosSerialWrapperNode > const &", "SWIGTYPE_Teuchos__RCPT_Kokkos__Compat__KokkosSerialWrapper9ZCDM", "Tpetra::Map< LO,GO,NO >::Map(Tpetra::global_size_t const,Teuchos::ArrayView< long long const > const &,long long const,Teuchos::RCP< Teuchos::Comm< int > const > const &,Teuchos::RCP< Kokkos::Compat::KokkosSerialWrapperNode > const &)", return SwigClassWrapper_uninitialized()); + arg5 = static_cast< Teuchos::RCP< Kokkos::Compat::KokkosSerialWrapperNode > * >(farg5->cptr); + { + // Make sure no unhandled exceptions exist before performing a new action + SWIG_check_unhandled_exception_impl("Tpetra::Map< LO,GO,NO >::Map(Tpetra::global_size_t const,Teuchos::ArrayView< long long const > const &,long long const,Teuchos::RCP< Teuchos::Comm< int > const > const &,Teuchos::RCP< Kokkos::Compat::KokkosSerialWrapperNode > const &)");; + try + { + // Attempt the wrapped function call + result = (Tpetra::Map< LO,GO,NO > *)new Tpetra::Map< LO,GO,NO >(arg1,(Teuchos::ArrayView< long long const > const &)*arg2,arg3,(Teuchos::RCP< Teuchos::Comm< int > const > const &)*arg4,(Teuchos::RCP< Kokkos::Compat::KokkosSerialWrapperNode > const &)*arg5); + } + catch (const std::range_error& e) + { + // Store a C++ exception + SWIG_exception_impl("Tpetra::Map< LO,GO,NO >::Map(Tpetra::global_size_t const,Teuchos::ArrayView< long long const > const &,long long const,Teuchos::RCP< Teuchos::Comm< int > const > const &,Teuchos::RCP< Kokkos::Compat::KokkosSerialWrapperNode > const &)", SWIG_IndexError, e.what(), return SwigClassWrapper_uninitialized()); + } + catch (const std::exception& e) + { + // Store a C++ exception + SWIG_exception_impl("Tpetra::Map< LO,GO,NO >::Map(Tpetra::global_size_t const,Teuchos::ArrayView< long long const > const &,long long const,Teuchos::RCP< Teuchos::Comm< int > const > const &,Teuchos::RCP< Kokkos::Compat::KokkosSerialWrapperNode > const &)", SWIG_RuntimeError, e.what(), return SwigClassWrapper_uninitialized()); + } + catch (...) + { + SWIG_exception_impl("Tpetra::Map< LO,GO,NO >::Map(Tpetra::global_size_t const,Teuchos::ArrayView< long long const > const &,long long const,Teuchos::RCP< Teuchos::Comm< int > const > const &,Teuchos::RCP< Kokkos::Compat::KokkosSerialWrapperNode > const &)", SWIG_UnknownError, "An unknown exception occurred", return SwigClassWrapper_uninitialized()); + } + } + fresult.cptr = result ? new Teuchos::RCP< Tpetra::Map >(result SWIG_NO_NULL_DELETER_1) : NULL; + fresult.mem = SWIG_MOVE; + return fresult; +} + + +SWIGEXPORT SwigClassWrapper _wrap_new_TpetraMap__SWIG_6(long const *farg1, SwigArrayWrapper *farg2, SwigClassWrapper const *farg4) { + SwigClassWrapper fresult ; + Tpetra::global_size_t arg1 ; + Teuchos::ArrayView< long long const > *arg2 = 0 ; + long long arg3 ; + Teuchos::RCP< Teuchos::Comm< int > const > *arg4 = 0 ; + Teuchos::ArrayView< long long const > tmparr2 ; + Teuchos::RCP< Teuchos::Comm< int > const > tempnull4 ; + Tpetra::Map< LO,GO,NO > *result = 0 ; + + { + arg3 = 1; + } + arg1 = static_cast< Tpetra::global_size_t >(*farg1); + tmparr2 = Teuchos::ArrayView(static_cast(farg2->data), farg2->size); + arg2 = &tmparr2; + arg4 = farg4->cptr ? static_cast< Teuchos::RCP< Teuchos::Comm< int > const > * >(farg4->cptr) : &tempnull4; + { + // Make sure no unhandled exceptions exist before performing a new action + SWIG_check_unhandled_exception_impl("Tpetra::Map< LO,GO,NO >::Map(Tpetra::global_size_t const,Teuchos::ArrayView< long long const > const &,long long const,Teuchos::RCP< Teuchos::Comm< int > const > const &)");; + try + { + // Attempt the wrapped function call + result = (Tpetra::Map< LO,GO,NO > *)new Tpetra::Map< LO,GO,NO >(arg1,(Teuchos::ArrayView< long long const > const &)*arg2,arg3,(Teuchos::RCP< Teuchos::Comm< int > const > const &)*arg4); + } + catch (const std::range_error& e) + { + // Store a C++ exception + SWIG_exception_impl("Tpetra::Map< LO,GO,NO >::Map(Tpetra::global_size_t const,Teuchos::ArrayView< long long const > const &,long long const,Teuchos::RCP< Teuchos::Comm< int > const > const &)", SWIG_IndexError, e.what(), return SwigClassWrapper_uninitialized()); + } + catch (const std::exception& e) + { + // Store a C++ exception + SWIG_exception_impl("Tpetra::Map< LO,GO,NO >::Map(Tpetra::global_size_t const,Teuchos::ArrayView< long long const > const &,long long const,Teuchos::RCP< Teuchos::Comm< int > const > const &)", SWIG_RuntimeError, e.what(), return SwigClassWrapper_uninitialized()); + } + catch (...) + { + SWIG_exception_impl("Tpetra::Map< LO,GO,NO >::Map(Tpetra::global_size_t const,Teuchos::ArrayView< long long const > const &,long long const,Teuchos::RCP< Teuchos::Comm< int > const > const &)", SWIG_UnknownError, "An unknown exception occurred", return SwigClassWrapper_uninitialized()); + } + } + fresult.cptr = result ? new Teuchos::RCP< Tpetra::Map >(result SWIG_NO_NULL_DELETER_1) : NULL; + fresult.mem = SWIG_MOVE; + return fresult; +} + + +SWIGEXPORT SwigClassWrapper _wrap_new_TpetraMap__SWIG_7() { SwigClassWrapper fresult ; Tpetra::Map< LO,GO,NO > *result = 0 ; @@ -1506,14 +1800,10 @@ SWIGEXPORT int _wrap_TpetraMap_getRemoteIndexList__SWIG_0(SwigClassWrapper const } } fresult = static_cast< int >(result); - - for (int i = 0; i < arg3->size(); i++) - (*arg3)[i]++; - - - for (int i = 0; i < arg4->size(); i++) - (*arg4)[i]++; - + for (int i = 0; i < tmparr3.size(); i++) + tmparr3[i] += 1; + for (int i = 0; i < tmparr4.size(); i++) + tmparr4[i] += 1; return fresult; } @@ -1558,10 +1848,8 @@ SWIGEXPORT int _wrap_TpetraMap_getRemoteIndexList__SWIG_1(SwigClassWrapper const } } fresult = static_cast< int >(result); - - for (int i = 0; i < arg3->size(); i++) - (*arg3)[i]++; - + for (int i = 0; i < tmparr3.size(); i++) + tmparr3[i] += 1; return fresult; } @@ -1872,37 +2160,37 @@ SWIGEXPORT int _wrap_TpetraMap_isSameAs(SwigClassWrapper const *farg1, SwigClass SWIGEXPORT int _wrap_TpetraMap_locallySameAs(SwigClassWrapper const *farg1, SwigClassWrapper const *farg2) { int fresult ; Tpetra::Map< LO,GO,NO > *arg1 = (Tpetra::Map< LO,GO,NO > *) 0 ; - Tpetra::Map< int,long long,Tpetra::Map< LO,GO,NO >::node_type > *arg2 = 0 ; + Tpetra::Map< int,long long,Tpetra::Map< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::node_type > *arg2 = 0 ; Teuchos::RCP< Tpetra::Map< LO,GO,NO > const > *smartarg1 ; Teuchos::RCP< Tpetra::Map< LO,GO,NO > const > *smartarg2 ; bool result; smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); arg1 = smartarg1 ? const_cast< Tpetra::Map* >(smartarg1->get()) : NULL; - SWIG_check_sp_nonnull(farg2, "Tpetra::Map< int,long long,Tpetra::Map< LO,GO,NO >::node_type > *", "TpetraMap", "Tpetra::Map< LO,GO,NO >::locallySameAs(Tpetra::Map< int,long long,Tpetra::Map< LO,GO,NO >::node_type > const &) const", return 0) + SWIG_check_sp_nonnull(farg2, "Tpetra::Map< int,long long,Tpetra::Map< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::node_type > *", "TpetraMap", "Tpetra::Map< LO,GO,NO >::locallySameAs(Tpetra::Map< int,long long,Tpetra::Map< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::node_type > const &) const", return 0) smartarg2 = static_cast< Teuchos::RCP >* >(farg2->cptr); arg2 = const_cast< Tpetra::Map* >(smartarg2->get()); { // Make sure no unhandled exceptions exist before performing a new action - SWIG_check_unhandled_exception_impl("Tpetra::Map< LO,GO,NO >::locallySameAs(Tpetra::Map< int,long long,Tpetra::Map< LO,GO,NO >::node_type > const &) const");; + SWIG_check_unhandled_exception_impl("Tpetra::Map< LO,GO,NO >::locallySameAs(Tpetra::Map< int,long long,Tpetra::Map< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::node_type > const &) const");; try { // Attempt the wrapped function call - result = (bool)((Tpetra::Map< LO,GO,NO > const *)arg1)->locallySameAs((Tpetra::Map< int,long long,Tpetra::Map< LO,GO,NO >::node_type > const &)*arg2); + result = (bool)((Tpetra::Map< LO,GO,NO > const *)arg1)->locallySameAs((Tpetra::Map< int,long long,Tpetra::Map< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::node_type > const &)*arg2); } catch (const std::range_error& e) { // Store a C++ exception - SWIG_exception_impl("Tpetra::Map< LO,GO,NO >::locallySameAs(Tpetra::Map< int,long long,Tpetra::Map< LO,GO,NO >::node_type > const &) const", SWIG_IndexError, e.what(), return 0); + SWIG_exception_impl("Tpetra::Map< LO,GO,NO >::locallySameAs(Tpetra::Map< int,long long,Tpetra::Map< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::node_type > const &) const", SWIG_IndexError, e.what(), return 0); } catch (const std::exception& e) { // Store a C++ exception - SWIG_exception_impl("Tpetra::Map< LO,GO,NO >::locallySameAs(Tpetra::Map< int,long long,Tpetra::Map< LO,GO,NO >::node_type > const &) const", SWIG_RuntimeError, e.what(), return 0); + SWIG_exception_impl("Tpetra::Map< LO,GO,NO >::locallySameAs(Tpetra::Map< int,long long,Tpetra::Map< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::node_type > const &) const", SWIG_RuntimeError, e.what(), return 0); } catch (...) { - SWIG_exception_impl("Tpetra::Map< LO,GO,NO >::locallySameAs(Tpetra::Map< int,long long,Tpetra::Map< LO,GO,NO >::node_type > const &) const", SWIG_UnknownError, "An unknown exception occurred", return 0); + SWIG_exception_impl("Tpetra::Map< LO,GO,NO >::locallySameAs(Tpetra::Map< int,long long,Tpetra::Map< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::node_type > const &) const", SWIG_UnknownError, "An unknown exception occurred", return 0); } } fresult = (result ? 1 : 0); @@ -1993,273 +2281,115 @@ SWIGEXPORT SwigArrayWrapper _wrap_TpetraMap_description(SwigClassWrapper const * Tpetra::Map< LO,GO,NO > *arg1 = (Tpetra::Map< LO,GO,NO > *) 0 ; Teuchos::RCP< Tpetra::Map< LO,GO,NO > const > *smartarg1 ; std::string result; - - smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); - arg1 = smartarg1 ? const_cast< Tpetra::Map* >(smartarg1->get()) : NULL; - { - // Make sure no unhandled exceptions exist before performing a new action - SWIG_check_unhandled_exception_impl("Tpetra::Map< LO,GO,NO >::description() const");; - try - { - // Attempt the wrapped function call - result = ((Tpetra::Map< LO,GO,NO > const *)arg1)->description(); - } - catch (const std::range_error& e) - { - // Store a C++ exception - SWIG_exception_impl("Tpetra::Map< LO,GO,NO >::description() const", SWIG_IndexError, e.what(), return SwigArrayWrapper_uninitialized()); - } - catch (const std::exception& e) - { - // Store a C++ exception - SWIG_exception_impl("Tpetra::Map< LO,GO,NO >::description() const", SWIG_RuntimeError, e.what(), return SwigArrayWrapper_uninitialized()); - } - catch (...) - { - SWIG_exception_impl("Tpetra::Map< LO,GO,NO >::description() const", SWIG_UnknownError, "An unknown exception occurred", return SwigArrayWrapper_uninitialized()); - } - } - fresult.size = (&result)->size(); - if (fresult.size > 0) { - fresult.data = malloc(fresult.size); - memcpy(fresult.data, (&result)->c_str(), fresult.size); - } else { - fresult.data = NULL; - } - return fresult; -} - - -SWIGEXPORT SwigClassWrapper _wrap_TpetraMap_removeEmptyProcesses(SwigClassWrapper const *farg1) { - SwigClassWrapper fresult ; - Tpetra::Map< LO,GO,NO > *arg1 = (Tpetra::Map< LO,GO,NO > *) 0 ; - Teuchos::RCP< Tpetra::Map< LO,GO,NO > const > *smartarg1 ; - Teuchos::RCP< Tpetra::Map< int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const > result; - - smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); - arg1 = smartarg1 ? const_cast< Tpetra::Map* >(smartarg1->get()) : NULL; - { - // Make sure no unhandled exceptions exist before performing a new action - SWIG_check_unhandled_exception_impl("Tpetra::Map< LO,GO,NO >::removeEmptyProcesses() const");; - try - { - // Attempt the wrapped function call - result = ((Tpetra::Map< LO,GO,NO > const *)arg1)->removeEmptyProcesses(); - } - catch (const std::range_error& e) - { - // Store a C++ exception - SWIG_exception_impl("Tpetra::Map< LO,GO,NO >::removeEmptyProcesses() const", SWIG_IndexError, e.what(), return SwigClassWrapper_uninitialized()); - } - catch (const std::exception& e) - { - // Store a C++ exception - SWIG_exception_impl("Tpetra::Map< LO,GO,NO >::removeEmptyProcesses() const", SWIG_RuntimeError, e.what(), return SwigClassWrapper_uninitialized()); - } - catch (...) - { - SWIG_exception_impl("Tpetra::Map< LO,GO,NO >::removeEmptyProcesses() const", SWIG_UnknownError, "An unknown exception occurred", return SwigClassWrapper_uninitialized()); - } - } - fresult.cptr = (new Teuchos::RCP >(static_cast< const Teuchos::RCP >& >(result))); - fresult.mem = SWIG_MOVE; - return fresult; -} - - -SWIGEXPORT SwigClassWrapper _wrap_TpetraMap_replaceCommWithSubset(SwigClassWrapper const *farg1, SwigClassWrapper const *farg2) { - SwigClassWrapper fresult ; - Tpetra::Map< LO,GO,NO > *arg1 = (Tpetra::Map< LO,GO,NO > *) 0 ; - Teuchos::RCP< Teuchos::Comm< int > const > *arg2 = 0 ; - Teuchos::RCP< Tpetra::Map< LO,GO,NO > const > *smartarg1 ; - Teuchos::RCP< Teuchos::Comm< int > const > tempnull2 ; - Teuchos::RCP< Tpetra::Map< int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const > result; - - smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); - arg1 = smartarg1 ? const_cast< Tpetra::Map* >(smartarg1->get()) : NULL; - arg2 = farg2->cptr ? static_cast< Teuchos::RCP< Teuchos::Comm< int > const > * >(farg2->cptr) : &tempnull2; - { - // Make sure no unhandled exceptions exist before performing a new action - SWIG_check_unhandled_exception_impl("Tpetra::Map< LO,GO,NO >::replaceCommWithSubset(Teuchos::RCP< Teuchos::Comm< int > const > const &) const");; - try - { - // Attempt the wrapped function call - result = ((Tpetra::Map< LO,GO,NO > const *)arg1)->replaceCommWithSubset((Teuchos::RCP< Teuchos::Comm< int > const > const &)*arg2); - } - catch (const std::range_error& e) - { - // Store a C++ exception - SWIG_exception_impl("Tpetra::Map< LO,GO,NO >::replaceCommWithSubset(Teuchos::RCP< Teuchos::Comm< int > const > const &) const", SWIG_IndexError, e.what(), return SwigClassWrapper_uninitialized()); - } - catch (const std::exception& e) - { - // Store a C++ exception - SWIG_exception_impl("Tpetra::Map< LO,GO,NO >::replaceCommWithSubset(Teuchos::RCP< Teuchos::Comm< int > const > const &) const", SWIG_RuntimeError, e.what(), return SwigClassWrapper_uninitialized()); - } - catch (...) - { - SWIG_exception_impl("Tpetra::Map< LO,GO,NO >::replaceCommWithSubset(Teuchos::RCP< Teuchos::Comm< int > const > const &) const", SWIG_UnknownError, "An unknown exception occurred", return SwigClassWrapper_uninitialized()); - } - } - fresult.cptr = (new Teuchos::RCP >(static_cast< const Teuchos::RCP >& >(result))); - fresult.mem = SWIG_MOVE; - return fresult; -} - - -SWIGEXPORT SwigClassWrapper _wrap_new_TpetraMap__SWIG_1(long const *farg1, SwigClassWrapper const *farg2, int const *farg3) { - SwigClassWrapper fresult ; - Tpetra::global_size_t arg1 ; - Teuchos::RCP< Teuchos::Comm< int > const > *arg2 = 0 ; - Tpetra::LocalGlobal arg3 ; - Teuchos::RCP< Teuchos::Comm< int > const > tempnull2 ; - Tpetra::Map< LO,GO,NO > *result = 0 ; - - arg1 = static_cast< Tpetra::global_size_t >(*farg1); - arg2 = farg2->cptr ? static_cast< Teuchos::RCP< Teuchos::Comm< int > const > * >(farg2->cptr) : &tempnull2; - arg3 = static_cast< Tpetra::LocalGlobal >(*farg3); - { - // Make sure no unhandled exceptions exist before performing a new action - SWIG_check_unhandled_exception_impl("Tpetra::Map< LO,GO,NO >::Map(Tpetra::global_size_t,Teuchos::RCP< Teuchos::Comm< int > const > const &,Tpetra::LocalGlobal)");; - try - { - // Attempt the wrapped function call - result = (Tpetra::Map< LO,GO,NO > *)new_Tpetra_Map_Sl_LO_Sc_GO_Sc_NO_Sg___SWIG_1(arg1,(Teuchos::RCP< Teuchos::Comm< int > const > const &)*arg2,arg3); - } - catch (const std::range_error& e) - { - // Store a C++ exception - SWIG_exception_impl("Tpetra::Map< LO,GO,NO >::Map(Tpetra::global_size_t,Teuchos::RCP< Teuchos::Comm< int > const > const &,Tpetra::LocalGlobal)", SWIG_IndexError, e.what(), return SwigClassWrapper_uninitialized()); - } - catch (const std::exception& e) - { - // Store a C++ exception - SWIG_exception_impl("Tpetra::Map< LO,GO,NO >::Map(Tpetra::global_size_t,Teuchos::RCP< Teuchos::Comm< int > const > const &,Tpetra::LocalGlobal)", SWIG_RuntimeError, e.what(), return SwigClassWrapper_uninitialized()); - } - catch (...) - { - SWIG_exception_impl("Tpetra::Map< LO,GO,NO >::Map(Tpetra::global_size_t,Teuchos::RCP< Teuchos::Comm< int > const > const &,Tpetra::LocalGlobal)", SWIG_UnknownError, "An unknown exception occurred", return SwigClassWrapper_uninitialized()); - } - } - fresult.cptr = result ? new Teuchos::RCP< Tpetra::Map >(result SWIG_NO_NULL_DELETER_1) : NULL; - fresult.mem = SWIG_MOVE; - return fresult; -} - - -SWIGEXPORT SwigClassWrapper _wrap_new_TpetraMap__SWIG_2(long const *farg1, SwigClassWrapper const *farg2) { - SwigClassWrapper fresult ; - Tpetra::global_size_t arg1 ; - Teuchos::RCP< Teuchos::Comm< int > const > *arg2 = 0 ; - Teuchos::RCP< Teuchos::Comm< int > const > tempnull2 ; - Tpetra::Map< LO,GO,NO > *result = 0 ; - - arg1 = static_cast< Tpetra::global_size_t >(*farg1); - arg2 = farg2->cptr ? static_cast< Teuchos::RCP< Teuchos::Comm< int > const > * >(farg2->cptr) : &tempnull2; + + smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::Map* >(smartarg1->get()) : NULL; { // Make sure no unhandled exceptions exist before performing a new action - SWIG_check_unhandled_exception_impl("Tpetra::Map< LO,GO,NO >::Map(Tpetra::global_size_t,Teuchos::RCP< Teuchos::Comm< int > const > const &)");; + SWIG_check_unhandled_exception_impl("Tpetra::Map< LO,GO,NO >::description() const");; try { // Attempt the wrapped function call - result = (Tpetra::Map< LO,GO,NO > *)new_Tpetra_Map_Sl_LO_Sc_GO_Sc_NO_Sg___SWIG_1(arg1,(Teuchos::RCP< Teuchos::Comm< int > const > const &)*arg2); + result = ((Tpetra::Map< LO,GO,NO > const *)arg1)->description(); } catch (const std::range_error& e) { // Store a C++ exception - SWIG_exception_impl("Tpetra::Map< LO,GO,NO >::Map(Tpetra::global_size_t,Teuchos::RCP< Teuchos::Comm< int > const > const &)", SWIG_IndexError, e.what(), return SwigClassWrapper_uninitialized()); + SWIG_exception_impl("Tpetra::Map< LO,GO,NO >::description() const", SWIG_IndexError, e.what(), return SwigArrayWrapper_uninitialized()); } catch (const std::exception& e) { // Store a C++ exception - SWIG_exception_impl("Tpetra::Map< LO,GO,NO >::Map(Tpetra::global_size_t,Teuchos::RCP< Teuchos::Comm< int > const > const &)", SWIG_RuntimeError, e.what(), return SwigClassWrapper_uninitialized()); + SWIG_exception_impl("Tpetra::Map< LO,GO,NO >::description() const", SWIG_RuntimeError, e.what(), return SwigArrayWrapper_uninitialized()); } catch (...) { - SWIG_exception_impl("Tpetra::Map< LO,GO,NO >::Map(Tpetra::global_size_t,Teuchos::RCP< Teuchos::Comm< int > const > const &)", SWIG_UnknownError, "An unknown exception occurred", return SwigClassWrapper_uninitialized()); + SWIG_exception_impl("Tpetra::Map< LO,GO,NO >::description() const", SWIG_UnknownError, "An unknown exception occurred", return SwigArrayWrapper_uninitialized()); } } - fresult.cptr = result ? new Teuchos::RCP< Tpetra::Map >(result SWIG_NO_NULL_DELETER_1) : NULL; - fresult.mem = SWIG_MOVE; + fresult.size = (&result)->size(); + if (fresult.size > 0) { + fresult.data = malloc(fresult.size); + memcpy(fresult.data, (&result)->c_str(), fresult.size); + } else { + fresult.data = NULL; + } return fresult; } -SWIGEXPORT SwigClassWrapper _wrap_new_TpetraMap__SWIG_3(long const *farg1, int const *farg2, SwigClassWrapper const *farg3) { +SWIGEXPORT SwigClassWrapper _wrap_TpetraMap_removeEmptyProcesses(SwigClassWrapper const *farg1) { SwigClassWrapper fresult ; - Tpetra::global_size_t arg1 ; - size_t arg2 ; - Teuchos::RCP< Teuchos::Comm< int > const > *arg3 = 0 ; - Teuchos::RCP< Teuchos::Comm< int > const > tempnull3 ; - Tpetra::Map< LO,GO,NO > *result = 0 ; + Tpetra::Map< LO,GO,NO > *arg1 = (Tpetra::Map< LO,GO,NO > *) 0 ; + Teuchos::RCP< Tpetra::Map< LO,GO,NO > const > *smartarg1 ; + Teuchos::RCP< Tpetra::Map< int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const > result; - arg1 = static_cast< Tpetra::global_size_t >(*farg1); - arg2 = static_cast< size_t >(*farg2); - arg3 = farg3->cptr ? static_cast< Teuchos::RCP< Teuchos::Comm< int > const > * >(farg3->cptr) : &tempnull3; + smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::Map* >(smartarg1->get()) : NULL; { // Make sure no unhandled exceptions exist before performing a new action - SWIG_check_unhandled_exception_impl("Tpetra::Map< LO,GO,NO >::Map(Tpetra::global_size_t,size_t,Teuchos::RCP< Teuchos::Comm< int > const > const &)");; + SWIG_check_unhandled_exception_impl("Tpetra::Map< LO,GO,NO >::removeEmptyProcesses() const");; try { // Attempt the wrapped function call - result = (Tpetra::Map< LO,GO,NO > *)new_Tpetra_Map_Sl_LO_Sc_GO_Sc_NO_Sg___SWIG_3(arg1,arg2,(Teuchos::RCP< Teuchos::Comm< int > const > const &)*arg3); + result = ((Tpetra::Map< LO,GO,NO > const *)arg1)->removeEmptyProcesses(); } catch (const std::range_error& e) { // Store a C++ exception - SWIG_exception_impl("Tpetra::Map< LO,GO,NO >::Map(Tpetra::global_size_t,size_t,Teuchos::RCP< Teuchos::Comm< int > const > const &)", SWIG_IndexError, e.what(), return SwigClassWrapper_uninitialized()); + SWIG_exception_impl("Tpetra::Map< LO,GO,NO >::removeEmptyProcesses() const", SWIG_IndexError, e.what(), return SwigClassWrapper_uninitialized()); } catch (const std::exception& e) { // Store a C++ exception - SWIG_exception_impl("Tpetra::Map< LO,GO,NO >::Map(Tpetra::global_size_t,size_t,Teuchos::RCP< Teuchos::Comm< int > const > const &)", SWIG_RuntimeError, e.what(), return SwigClassWrapper_uninitialized()); + SWIG_exception_impl("Tpetra::Map< LO,GO,NO >::removeEmptyProcesses() const", SWIG_RuntimeError, e.what(), return SwigClassWrapper_uninitialized()); } catch (...) { - SWIG_exception_impl("Tpetra::Map< LO,GO,NO >::Map(Tpetra::global_size_t,size_t,Teuchos::RCP< Teuchos::Comm< int > const > const &)", SWIG_UnknownError, "An unknown exception occurred", return SwigClassWrapper_uninitialized()); + SWIG_exception_impl("Tpetra::Map< LO,GO,NO >::removeEmptyProcesses() const", SWIG_UnknownError, "An unknown exception occurred", return SwigClassWrapper_uninitialized()); } } - fresult.cptr = result ? new Teuchos::RCP< Tpetra::Map >(result SWIG_NO_NULL_DELETER_1) : NULL; + fresult.cptr = (new Teuchos::RCP >(static_cast< const Teuchos::RCP >& >(result))); fresult.mem = SWIG_MOVE; return fresult; } -SWIGEXPORT SwigClassWrapper _wrap_new_TpetraMap__SWIG_4(long const *farg1, SwigArrayWrapper *farg2, SwigClassWrapper const *farg3) { +SWIGEXPORT SwigClassWrapper _wrap_TpetraMap_replaceCommWithSubset(SwigClassWrapper const *farg1, SwigClassWrapper const *farg2) { SwigClassWrapper fresult ; - Tpetra::global_size_t arg1 ; - Teuchos::ArrayView< GO const > arg2 ; - Teuchos::RCP< Teuchos::Comm< int > const > *arg3 = 0 ; - Teuchos::RCP< Teuchos::Comm< int > const > tempnull3 ; - Tpetra::Map< LO,GO,NO > *result = 0 ; + Tpetra::Map< LO,GO,NO > *arg1 = (Tpetra::Map< LO,GO,NO > *) 0 ; + Teuchos::RCP< Teuchos::Comm< int > const > *arg2 = 0 ; + Teuchos::RCP< Tpetra::Map< LO,GO,NO > const > *smartarg1 ; + Teuchos::RCP< Teuchos::Comm< int > const > tempnull2 ; + Teuchos::RCP< Tpetra::Map< int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const > result; - arg1 = static_cast< Tpetra::global_size_t >(*farg1); - arg2 = Teuchos::ArrayView(static_cast(farg2->data), farg2->size); - arg3 = farg3->cptr ? static_cast< Teuchos::RCP< Teuchos::Comm< int > const > * >(farg3->cptr) : &tempnull3; + smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::Map* >(smartarg1->get()) : NULL; + arg2 = farg2->cptr ? static_cast< Teuchos::RCP< Teuchos::Comm< int > const > * >(farg2->cptr) : &tempnull2; { // Make sure no unhandled exceptions exist before performing a new action - SWIG_check_unhandled_exception_impl("Tpetra::Map< LO,GO,NO >::Map(Tpetra::global_size_t const,Teuchos::ArrayView< GO const >,Teuchos::RCP< Teuchos::Comm< int > const > const &)");; + SWIG_check_unhandled_exception_impl("Tpetra::Map< LO,GO,NO >::replaceCommWithSubset(Teuchos::RCP< Teuchos::Comm< int > const > const &) const");; try { // Attempt the wrapped function call - result = (Tpetra::Map< LO,GO,NO > *)new_Tpetra_Map_Sl_LO_Sc_GO_Sc_NO_Sg___SWIG_4(arg1,arg2,(Teuchos::RCP< Teuchos::Comm< int > const > const &)*arg3); + result = ((Tpetra::Map< LO,GO,NO > const *)arg1)->replaceCommWithSubset((Teuchos::RCP< Teuchos::Comm< int > const > const &)*arg2); } catch (const std::range_error& e) { // Store a C++ exception - SWIG_exception_impl("Tpetra::Map< LO,GO,NO >::Map(Tpetra::global_size_t const,Teuchos::ArrayView< GO const >,Teuchos::RCP< Teuchos::Comm< int > const > const &)", SWIG_IndexError, e.what(), return SwigClassWrapper_uninitialized()); + SWIG_exception_impl("Tpetra::Map< LO,GO,NO >::replaceCommWithSubset(Teuchos::RCP< Teuchos::Comm< int > const > const &) const", SWIG_IndexError, e.what(), return SwigClassWrapper_uninitialized()); } catch (const std::exception& e) { // Store a C++ exception - SWIG_exception_impl("Tpetra::Map< LO,GO,NO >::Map(Tpetra::global_size_t const,Teuchos::ArrayView< GO const >,Teuchos::RCP< Teuchos::Comm< int > const > const &)", SWIG_RuntimeError, e.what(), return SwigClassWrapper_uninitialized()); + SWIG_exception_impl("Tpetra::Map< LO,GO,NO >::replaceCommWithSubset(Teuchos::RCP< Teuchos::Comm< int > const > const &) const", SWIG_RuntimeError, e.what(), return SwigClassWrapper_uninitialized()); } catch (...) { - SWIG_exception_impl("Tpetra::Map< LO,GO,NO >::Map(Tpetra::global_size_t const,Teuchos::ArrayView< GO const >,Teuchos::RCP< Teuchos::Comm< int > const > const &)", SWIG_UnknownError, "An unknown exception occurred", return SwigClassWrapper_uninitialized()); + SWIG_exception_impl("Tpetra::Map< LO,GO,NO >::replaceCommWithSubset(Teuchos::RCP< Teuchos::Comm< int > const > const &) const", SWIG_UnknownError, "An unknown exception occurred", return SwigClassWrapper_uninitialized()); } } - fresult.cptr = result ? new Teuchos::RCP< Tpetra::Map >(result SWIG_NO_NULL_DELETER_1) : NULL; + fresult.cptr = (new Teuchos::RCP >(static_cast< const Teuchos::RCP >& >(result))); fresult.mem = SWIG_MOVE; return fresult; } @@ -10549,114 +10679,354 @@ SWIGEXPORT SwigClassWrapper _wrap_new_TpetraCrsMatrix__SWIG_8(SwigClassWrapper c arg3 = farg3->cptr ? static_cast< Teuchos::RCP< Teuchos::ParameterList > * >(farg3->cptr) : &tempnull3; { // Make sure no unhandled exceptions exist before performing a new action - SWIG_check_unhandled_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::CrsMatrix(Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::crs_graph_type const > const &,Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::local_matrix_type::values_type const &,Teuchos::RCP< Teuchos::ParameterList > const &)");; + SWIG_check_unhandled_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::CrsMatrix(Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::crs_graph_type const > const &,Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::local_matrix_type::values_type const &,Teuchos::RCP< Teuchos::ParameterList > const &)");; + try + { + // Attempt the wrapped function call + result = (Tpetra::CrsMatrix< SC,LO,GO,NO > *)new Tpetra::CrsMatrix< SC,LO,GO,NO >((Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::crs_graph_type const > const &)*arg1,(Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::local_matrix_type::values_type const &)*arg2,(Teuchos::RCP< Teuchos::ParameterList > const &)*arg3); + } + catch (const std::range_error& e) + { + // Store a C++ exception + SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::CrsMatrix(Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::crs_graph_type const > const &,Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::local_matrix_type::values_type const &,Teuchos::RCP< Teuchos::ParameterList > const &)", SWIG_IndexError, e.what(), return SwigClassWrapper_uninitialized()); + } + catch (const std::exception& e) + { + // Store a C++ exception + SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::CrsMatrix(Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::crs_graph_type const > const &,Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::local_matrix_type::values_type const &,Teuchos::RCP< Teuchos::ParameterList > const &)", SWIG_RuntimeError, e.what(), return SwigClassWrapper_uninitialized()); + } + catch (...) + { + SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::CrsMatrix(Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::crs_graph_type const > const &,Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::local_matrix_type::values_type const &,Teuchos::RCP< Teuchos::ParameterList > const &)", SWIG_UnknownError, "An unknown exception occurred", return SwigClassWrapper_uninitialized()); + } + } + fresult.cptr = result ? new Teuchos::RCP< Tpetra::CrsMatrix >(result SWIG_NO_NULL_DELETER_1) : NULL; + fresult.mem = SWIG_MOVE; + return fresult; +} + + +SWIGEXPORT SwigClassWrapper _wrap_new_TpetraCrsMatrix__SWIG_9(SwigClassWrapper const *farg1, SwigClassWrapper const *farg2) { + SwigClassWrapper fresult ; + Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::crs_graph_type const > *arg1 = 0 ; + Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::local_matrix_type::values_type *arg2 = 0 ; + Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::crs_graph_type const > tempnull1 ; + Tpetra::CrsMatrix< SC,LO,GO,NO > *result = 0 ; + + arg1 = farg1->cptr ? static_cast< Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::crs_graph_type const > * >(farg1->cptr) : &tempnull1; + SWIG_check_nonnull(*farg2, "Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::local_matrix_type::values_type const &", "SWIGTYPE_KokkosSparse__CrsMatrixT_Tpetra__CrsMatrixT_doub1E12GN", "Tpetra::CrsMatrix< SC,LO,GO,NO >::CrsMatrix(Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::crs_graph_type const > const &,Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::local_matrix_type::values_type const &)", return SwigClassWrapper_uninitialized()); + arg2 = static_cast< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::local_matrix_type::values_type * >(farg2->cptr); + { + // Make sure no unhandled exceptions exist before performing a new action + SWIG_check_unhandled_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::CrsMatrix(Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::crs_graph_type const > const &,Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::local_matrix_type::values_type const &)");; + try + { + // Attempt the wrapped function call + result = (Tpetra::CrsMatrix< SC,LO,GO,NO > *)new Tpetra::CrsMatrix< SC,LO,GO,NO >((Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::crs_graph_type const > const &)*arg1,(Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::local_matrix_type::values_type const &)*arg2); + } + catch (const std::range_error& e) + { + // Store a C++ exception + SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::CrsMatrix(Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::crs_graph_type const > const &,Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::local_matrix_type::values_type const &)", SWIG_IndexError, e.what(), return SwigClassWrapper_uninitialized()); + } + catch (const std::exception& e) + { + // Store a C++ exception + SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::CrsMatrix(Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::crs_graph_type const > const &,Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::local_matrix_type::values_type const &)", SWIG_RuntimeError, e.what(), return SwigClassWrapper_uninitialized()); + } + catch (...) + { + SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::CrsMatrix(Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::crs_graph_type const > const &,Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::local_matrix_type::values_type const &)", SWIG_UnknownError, "An unknown exception occurred", return SwigClassWrapper_uninitialized()); + } + } + fresult.cptr = result ? new Teuchos::RCP< Tpetra::CrsMatrix >(result SWIG_NO_NULL_DELETER_1) : NULL; + fresult.mem = SWIG_MOVE; + return fresult; +} + + +SWIGEXPORT void _wrap_delete_TpetraCrsMatrix(SwigClassWrapper const *farg1) { + Tpetra::CrsMatrix< SC,LO,GO,NO > *arg1 = (Tpetra::CrsMatrix< SC,LO,GO,NO > *) 0 ; + Teuchos::RCP< Tpetra::CrsMatrix< SC,LO,GO,NO > > *smartarg1 ; + + smartarg1 = static_cast< Teuchos::RCP< Tpetra::CrsMatrix >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::CrsMatrix* >(smartarg1->get()) : NULL; + { + // Make sure no unhandled exceptions exist before performing a new action + SWIG_check_unhandled_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::~CrsMatrix()");; + try + { + // Attempt the wrapped function call + (void)arg1; delete smartarg1; + } + catch (const std::range_error& e) + { + // Store a C++ exception + SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::~CrsMatrix()", SWIG_IndexError, e.what(), return ); + } + catch (const std::exception& e) + { + // Store a C++ exception + SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::~CrsMatrix()", SWIG_RuntimeError, e.what(), return ); + } + catch (...) + { + SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::~CrsMatrix()", SWIG_UnknownError, "An unknown exception occurred", return ); + } + } + +} + + +SWIGEXPORT void _wrap_TpetraCrsMatrix_insertGlobalValues(SwigClassWrapper const *farg1, long long const *farg2, SwigArrayWrapper *farg3, SwigArrayWrapper *farg4) { + Tpetra::CrsMatrix< SC,LO,GO,NO > *arg1 = (Tpetra::CrsMatrix< SC,LO,GO,NO > *) 0 ; + long long arg2 ; + Teuchos::ArrayView< long long const > *arg3 = 0 ; + Teuchos::ArrayView< double const > *arg4 = 0 ; + Teuchos::RCP< Tpetra::CrsMatrix< SC,LO,GO,NO > > *smartarg1 ; + Teuchos::ArrayView< long long const > tmparr3 ; + Teuchos::ArrayView< double const > tmparr4 ; + + smartarg1 = static_cast< Teuchos::RCP< Tpetra::CrsMatrix >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::CrsMatrix* >(smartarg1->get()) : NULL; + arg2 = static_cast< long long >(*farg2); + tmparr3 = Teuchos::ArrayView(static_cast(farg3->data), farg3->size); + arg3 = &tmparr3; + tmparr4 = Teuchos::ArrayView(static_cast(farg4->data), farg4->size); + arg4 = &tmparr4; + { + // Make sure no unhandled exceptions exist before performing a new action + SWIG_check_unhandled_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::insertGlobalValues(long long const,Teuchos::ArrayView< long long const > const &,Teuchos::ArrayView< double const > const &)");; + try + { + // Attempt the wrapped function call + (arg1)->insertGlobalValues(arg2,(Teuchos::ArrayView< long long const > const &)*arg3,(Teuchos::ArrayView< double const > const &)*arg4); + } + catch (const std::range_error& e) + { + // Store a C++ exception + SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::insertGlobalValues(long long const,Teuchos::ArrayView< long long const > const &,Teuchos::ArrayView< double const > const &)", SWIG_IndexError, e.what(), return ); + } + catch (const std::exception& e) + { + // Store a C++ exception + SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::insertGlobalValues(long long const,Teuchos::ArrayView< long long const > const &,Teuchos::ArrayView< double const > const &)", SWIG_RuntimeError, e.what(), return ); + } + catch (...) + { + SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::insertGlobalValues(long long const,Teuchos::ArrayView< long long const > const &,Teuchos::ArrayView< double const > const &)", SWIG_UnknownError, "An unknown exception occurred", return ); + } + } + +} + + +SWIGEXPORT void _wrap_TpetraCrsMatrix_insertLocalValues(SwigClassWrapper const *farg1, int const *farg2, SwigArrayWrapper *farg3, SwigArrayWrapper *farg4) { + Tpetra::CrsMatrix< SC,LO,GO,NO > *arg1 = (Tpetra::CrsMatrix< SC,LO,GO,NO > *) 0 ; + int arg2 ; + Teuchos::ArrayView< int const > *arg3 = 0 ; + Teuchos::ArrayView< double const > *arg4 = 0 ; + Teuchos::RCP< Tpetra::CrsMatrix< SC,LO,GO,NO > > *smartarg1 ; + Teuchos::ArrayView< int const >::value_type *tmpbegin3 ; + Teuchos::Array< std::remove_const< Teuchos::ArrayView< int const >::value_type >::type > tmparr3 ; + Teuchos::ArrayView< int const > tmpview3 ; + Teuchos::ArrayView< double const > tmparr4 ; + + smartarg1 = static_cast< Teuchos::RCP< Tpetra::CrsMatrix >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::CrsMatrix* >(smartarg1->get()) : NULL; + arg2 = *farg2 - 1; + tmpbegin3 = static_cast::value_type*>(farg3->data); + tmparr3.resize(farg3->size); + for (int i = 0; i < tmparr3.size(); i++) + tmparr3[i] = tmpbegin3[i] - 1; + tmpview3 = tmparr3(); + arg3 = &tmpview3; + tmparr4 = Teuchos::ArrayView(static_cast(farg4->data), farg4->size); + arg4 = &tmparr4; + { + // Make sure no unhandled exceptions exist before performing a new action + SWIG_check_unhandled_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::insertLocalValues(int const,Teuchos::ArrayView< int const > const &,Teuchos::ArrayView< double const > const &)");; + try + { + // Attempt the wrapped function call + (arg1)->insertLocalValues(arg2,(Teuchos::ArrayView< int const > const &)*arg3,(Teuchos::ArrayView< double const > const &)*arg4); + } + catch (const std::range_error& e) + { + // Store a C++ exception + SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::insertLocalValues(int const,Teuchos::ArrayView< int const > const &,Teuchos::ArrayView< double const > const &)", SWIG_IndexError, e.what(), return ); + } + catch (const std::exception& e) + { + // Store a C++ exception + SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::insertLocalValues(int const,Teuchos::ArrayView< int const > const &,Teuchos::ArrayView< double const > const &)", SWIG_RuntimeError, e.what(), return ); + } + catch (...) + { + SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::insertLocalValues(int const,Teuchos::ArrayView< int const > const &,Teuchos::ArrayView< double const > const &)", SWIG_UnknownError, "An unknown exception occurred", return ); + } + } + +} + + +SWIGEXPORT int _wrap_TpetraCrsMatrix_replaceGlobalValues(SwigClassWrapper const *farg1, long long const *farg2, SwigArrayWrapper *farg3, SwigArrayWrapper *farg4) { + int fresult ; + Tpetra::CrsMatrix< SC,LO,GO,NO > *arg1 = (Tpetra::CrsMatrix< SC,LO,GO,NO > *) 0 ; + long long arg2 ; + Teuchos::ArrayView< long long const > *arg3 = 0 ; + Teuchos::ArrayView< double const > *arg4 = 0 ; + Teuchos::RCP< Tpetra::CrsMatrix< SC,LO,GO,NO > const > *smartarg1 ; + Teuchos::ArrayView< long long const > tmparr3 ; + Teuchos::ArrayView< double const > tmparr4 ; + int result; + + smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::CrsMatrix* >(smartarg1->get()) : NULL; + arg2 = static_cast< long long >(*farg2); + tmparr3 = Teuchos::ArrayView(static_cast(farg3->data), farg3->size); + arg3 = &tmparr3; + tmparr4 = Teuchos::ArrayView(static_cast(farg4->data), farg4->size); + arg4 = &tmparr4; + { + // Make sure no unhandled exceptions exist before performing a new action + SWIG_check_unhandled_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::replaceGlobalValues(long long const,Teuchos::ArrayView< long long const > const &,Teuchos::ArrayView< double const > const &) const");; try { // Attempt the wrapped function call - result = (Tpetra::CrsMatrix< SC,LO,GO,NO > *)new Tpetra::CrsMatrix< SC,LO,GO,NO >((Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::crs_graph_type const > const &)*arg1,(Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::local_matrix_type::values_type const &)*arg2,(Teuchos::RCP< Teuchos::ParameterList > const &)*arg3); + result = (int)((Tpetra::CrsMatrix< SC,LO,GO,NO > const *)arg1)->replaceGlobalValues(arg2,(Teuchos::ArrayView< long long const > const &)*arg3,(Teuchos::ArrayView< double const > const &)*arg4); } catch (const std::range_error& e) { // Store a C++ exception - SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::CrsMatrix(Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::crs_graph_type const > const &,Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::local_matrix_type::values_type const &,Teuchos::RCP< Teuchos::ParameterList > const &)", SWIG_IndexError, e.what(), return SwigClassWrapper_uninitialized()); + SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::replaceGlobalValues(long long const,Teuchos::ArrayView< long long const > const &,Teuchos::ArrayView< double const > const &) const", SWIG_IndexError, e.what(), return 0); } catch (const std::exception& e) { // Store a C++ exception - SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::CrsMatrix(Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::crs_graph_type const > const &,Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::local_matrix_type::values_type const &,Teuchos::RCP< Teuchos::ParameterList > const &)", SWIG_RuntimeError, e.what(), return SwigClassWrapper_uninitialized()); + SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::replaceGlobalValues(long long const,Teuchos::ArrayView< long long const > const &,Teuchos::ArrayView< double const > const &) const", SWIG_RuntimeError, e.what(), return 0); } catch (...) { - SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::CrsMatrix(Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::crs_graph_type const > const &,Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::local_matrix_type::values_type const &,Teuchos::RCP< Teuchos::ParameterList > const &)", SWIG_UnknownError, "An unknown exception occurred", return SwigClassWrapper_uninitialized()); + SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::replaceGlobalValues(long long const,Teuchos::ArrayView< long long const > const &,Teuchos::ArrayView< double const > const &) const", SWIG_UnknownError, "An unknown exception occurred", return 0); } } - fresult.cptr = result ? new Teuchos::RCP< Tpetra::CrsMatrix >(result SWIG_NO_NULL_DELETER_1) : NULL; - fresult.mem = SWIG_MOVE; + fresult = static_cast< int >(result); return fresult; } -SWIGEXPORT SwigClassWrapper _wrap_new_TpetraCrsMatrix__SWIG_9(SwigClassWrapper const *farg1, SwigClassWrapper const *farg2) { - SwigClassWrapper fresult ; - Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::crs_graph_type const > *arg1 = 0 ; - Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::local_matrix_type::values_type *arg2 = 0 ; - Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::crs_graph_type const > tempnull1 ; - Tpetra::CrsMatrix< SC,LO,GO,NO > *result = 0 ; +SWIGEXPORT int _wrap_TpetraCrsMatrix_replaceLocalValues__SWIG_1(SwigClassWrapper const *farg1, int const *farg2, SwigArrayWrapper *farg3, SwigArrayWrapper *farg4) { + int fresult ; + Tpetra::CrsMatrix< SC,LO,GO,NO > *arg1 = (Tpetra::CrsMatrix< SC,LO,GO,NO > *) 0 ; + int arg2 ; + Teuchos::ArrayView< int const > *arg3 = 0 ; + Teuchos::ArrayView< double const > *arg4 = 0 ; + Teuchos::RCP< Tpetra::CrsMatrix< SC,LO,GO,NO > const > *smartarg1 ; + Teuchos::ArrayView< int const >::value_type *tmpbegin3 ; + Teuchos::Array< std::remove_const< Teuchos::ArrayView< int const >::value_type >::type > tmparr3 ; + Teuchos::ArrayView< int const > tmpview3 ; + Teuchos::ArrayView< double const > tmparr4 ; + int result; - arg1 = farg1->cptr ? static_cast< Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::crs_graph_type const > * >(farg1->cptr) : &tempnull1; - SWIG_check_nonnull(*farg2, "Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::local_matrix_type::values_type const &", "SWIGTYPE_KokkosSparse__CrsMatrixT_Tpetra__CrsMatrixT_doub1E12GN", "Tpetra::CrsMatrix< SC,LO,GO,NO >::CrsMatrix(Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::crs_graph_type const > const &,Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::local_matrix_type::values_type const &)", return SwigClassWrapper_uninitialized()); - arg2 = static_cast< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::local_matrix_type::values_type * >(farg2->cptr); + smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::CrsMatrix* >(smartarg1->get()) : NULL; + arg2 = *farg2 - 1; + tmpbegin3 = static_cast::value_type*>(farg3->data); + tmparr3.resize(farg3->size); + for (int i = 0; i < tmparr3.size(); i++) + tmparr3[i] = tmpbegin3[i] - 1; + tmpview3 = tmparr3(); + arg3 = &tmpview3; + tmparr4 = Teuchos::ArrayView(static_cast(farg4->data), farg4->size); + arg4 = &tmparr4; { // Make sure no unhandled exceptions exist before performing a new action - SWIG_check_unhandled_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::CrsMatrix(Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::crs_graph_type const > const &,Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::local_matrix_type::values_type const &)");; + SWIG_check_unhandled_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::replaceLocalValues(int const,Teuchos::ArrayView< int const > const &,Teuchos::ArrayView< double const > const &) const");; try { // Attempt the wrapped function call - result = (Tpetra::CrsMatrix< SC,LO,GO,NO > *)new Tpetra::CrsMatrix< SC,LO,GO,NO >((Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::crs_graph_type const > const &)*arg1,(Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::local_matrix_type::values_type const &)*arg2); + result = (int)((Tpetra::CrsMatrix< SC,LO,GO,NO > const *)arg1)->replaceLocalValues(arg2,(Teuchos::ArrayView< int const > const &)*arg3,(Teuchos::ArrayView< double const > const &)*arg4); } catch (const std::range_error& e) { // Store a C++ exception - SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::CrsMatrix(Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::crs_graph_type const > const &,Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::local_matrix_type::values_type const &)", SWIG_IndexError, e.what(), return SwigClassWrapper_uninitialized()); + SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::replaceLocalValues(int const,Teuchos::ArrayView< int const > const &,Teuchos::ArrayView< double const > const &) const", SWIG_IndexError, e.what(), return 0); } catch (const std::exception& e) { // Store a C++ exception - SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::CrsMatrix(Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::crs_graph_type const > const &,Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::local_matrix_type::values_type const &)", SWIG_RuntimeError, e.what(), return SwigClassWrapper_uninitialized()); + SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::replaceLocalValues(int const,Teuchos::ArrayView< int const > const &,Teuchos::ArrayView< double const > const &) const", SWIG_RuntimeError, e.what(), return 0); } catch (...) { - SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::CrsMatrix(Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::crs_graph_type const > const &,Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::local_matrix_type::values_type const &)", SWIG_UnknownError, "An unknown exception occurred", return SwigClassWrapper_uninitialized()); + SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::replaceLocalValues(int const,Teuchos::ArrayView< int const > const &,Teuchos::ArrayView< double const > const &) const", SWIG_UnknownError, "An unknown exception occurred", return 0); } } - fresult.cptr = result ? new Teuchos::RCP< Tpetra::CrsMatrix >(result SWIG_NO_NULL_DELETER_1) : NULL; - fresult.mem = SWIG_MOVE; + fresult = static_cast< int >(result); return fresult; } -SWIGEXPORT void _wrap_delete_TpetraCrsMatrix(SwigClassWrapper const *farg1) { +SWIGEXPORT int _wrap_TpetraCrsMatrix_replaceLocalValues__SWIG_2(SwigClassWrapper const *farg1, int const *farg2, int const *farg3, double const *farg4, int const *farg5) { + int fresult ; Tpetra::CrsMatrix< SC,LO,GO,NO > *arg1 = (Tpetra::CrsMatrix< SC,LO,GO,NO > *) 0 ; - Teuchos::RCP< Tpetra::CrsMatrix< SC,LO,GO,NO > > *smartarg1 ; + int arg2 ; + int arg3 ; + double *arg4 ; + int *arg5 ; + Teuchos::RCP< Tpetra::CrsMatrix< SC,LO,GO,NO > const > *smartarg1 ; + int result; - smartarg1 = static_cast< Teuchos::RCP< Tpetra::CrsMatrix >* >(farg1->cptr); + smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); arg1 = smartarg1 ? const_cast< Tpetra::CrsMatrix* >(smartarg1->get()) : NULL; + arg2 = *farg2 - 1; + arg3 = static_cast< int >(*farg3); + arg4 = const_cast< double * >(farg4); + arg5 = const_cast< int * >(farg5); { // Make sure no unhandled exceptions exist before performing a new action - SWIG_check_unhandled_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::~CrsMatrix()");; + SWIG_check_unhandled_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::replaceLocalValues(int const,int const,double const [],int const []) const");; try { // Attempt the wrapped function call - (void)arg1; delete smartarg1; + result = (int)((Tpetra::CrsMatrix< SC,LO,GO,NO > const *)arg1)->replaceLocalValues(arg2,arg3,(double const (*))arg4,(int const (*))arg5); } catch (const std::range_error& e) { // Store a C++ exception - SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::~CrsMatrix()", SWIG_IndexError, e.what(), return ); + SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::replaceLocalValues(int const,int const,double const [],int const []) const", SWIG_IndexError, e.what(), return 0); } catch (const std::exception& e) { // Store a C++ exception - SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::~CrsMatrix()", SWIG_RuntimeError, e.what(), return ); + SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::replaceLocalValues(int const,int const,double const [],int const []) const", SWIG_RuntimeError, e.what(), return 0); } catch (...) { - SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::~CrsMatrix()", SWIG_UnknownError, "An unknown exception occurred", return ); + SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::replaceLocalValues(int const,int const,double const [],int const []) const", SWIG_UnknownError, "An unknown exception occurred", return 0); } } - + fresult = static_cast< int >(result); + return fresult; } -SWIGEXPORT void _wrap_TpetraCrsMatrix_insertGlobalValues(SwigClassWrapper const *farg1, long long const *farg2, SwigArrayWrapper *farg3, SwigArrayWrapper *farg4) { +SWIGEXPORT int _wrap_TpetraCrsMatrix_sumIntoGlobalValues__SWIG_0(SwigClassWrapper const *farg1, long long const *farg2, SwigArrayWrapper *farg3, SwigArrayWrapper *farg4) { + int fresult ; Tpetra::CrsMatrix< SC,LO,GO,NO > *arg1 = (Tpetra::CrsMatrix< SC,LO,GO,NO > *) 0 ; long long arg2 ; Teuchos::ArrayView< long long const > *arg3 = 0 ; Teuchos::ArrayView< double const > *arg4 = 0 ; + bool arg5 ; Teuchos::RCP< Tpetra::CrsMatrix< SC,LO,GO,NO > > *smartarg1 ; Teuchos::ArrayView< long long const > tmparr3 ; Teuchos::ArrayView< double const > tmparr4 ; + int result; + { + arg5 = false; + } smartarg1 = static_cast< Teuchos::RCP< Tpetra::CrsMatrix >* >(farg1->cptr); arg1 = smartarg1 ? const_cast< Tpetra::CrsMatrix* >(smartarg1->get()) : NULL; arg2 = static_cast< long long >(*farg2); @@ -10666,70 +11036,81 @@ SWIGEXPORT void _wrap_TpetraCrsMatrix_insertGlobalValues(SwigClassWrapper const arg4 = &tmparr4; { // Make sure no unhandled exceptions exist before performing a new action - SWIG_check_unhandled_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::insertGlobalValues(long long const,Teuchos::ArrayView< long long const > const &,Teuchos::ArrayView< double const > const &)");; + SWIG_check_unhandled_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::sumIntoGlobalValues(long long const,Teuchos::ArrayView< long long const > const &,Teuchos::ArrayView< double const > const &,bool const)");; try { // Attempt the wrapped function call - (arg1)->insertGlobalValues(arg2,(Teuchos::ArrayView< long long const > const &)*arg3,(Teuchos::ArrayView< double const > const &)*arg4); + result = (int)(arg1)->sumIntoGlobalValues(arg2,(Teuchos::ArrayView< long long const > const &)*arg3,(Teuchos::ArrayView< double const > const &)*arg4,arg5); } catch (const std::range_error& e) { // Store a C++ exception - SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::insertGlobalValues(long long const,Teuchos::ArrayView< long long const > const &,Teuchos::ArrayView< double const > const &)", SWIG_IndexError, e.what(), return ); + SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::sumIntoGlobalValues(long long const,Teuchos::ArrayView< long long const > const &,Teuchos::ArrayView< double const > const &,bool const)", SWIG_IndexError, e.what(), return 0); } catch (const std::exception& e) { // Store a C++ exception - SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::insertGlobalValues(long long const,Teuchos::ArrayView< long long const > const &,Teuchos::ArrayView< double const > const &)", SWIG_RuntimeError, e.what(), return ); + SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::sumIntoGlobalValues(long long const,Teuchos::ArrayView< long long const > const &,Teuchos::ArrayView< double const > const &,bool const)", SWIG_RuntimeError, e.what(), return 0); } catch (...) { - SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::insertGlobalValues(long long const,Teuchos::ArrayView< long long const > const &,Teuchos::ArrayView< double const > const &)", SWIG_UnknownError, "An unknown exception occurred", return ); + SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::sumIntoGlobalValues(long long const,Teuchos::ArrayView< long long const > const &,Teuchos::ArrayView< double const > const &,bool const)", SWIG_UnknownError, "An unknown exception occurred", return 0); } } - + fresult = static_cast< int >(result); + return fresult; } -SWIGEXPORT int _wrap_TpetraCrsMatrix_replaceGlobalValues(SwigClassWrapper const *farg1, long long const *farg2, SwigArrayWrapper *farg3, SwigArrayWrapper *farg4) { +SWIGEXPORT int _wrap_TpetraCrsMatrix_sumIntoLocalValues__SWIG_0(SwigClassWrapper const *farg1, int const *farg2, SwigArrayWrapper *farg3, SwigArrayWrapper *farg4) { int fresult ; Tpetra::CrsMatrix< SC,LO,GO,NO > *arg1 = (Tpetra::CrsMatrix< SC,LO,GO,NO > *) 0 ; - long long arg2 ; - Teuchos::ArrayView< long long const > *arg3 = 0 ; + int arg2 ; + Teuchos::ArrayView< int const > *arg3 = 0 ; Teuchos::ArrayView< double const > *arg4 = 0 ; + bool arg5 ; Teuchos::RCP< Tpetra::CrsMatrix< SC,LO,GO,NO > const > *smartarg1 ; - Teuchos::ArrayView< long long const > tmparr3 ; + Teuchos::ArrayView< int const >::value_type *tmpbegin3 ; + Teuchos::Array< std::remove_const< Teuchos::ArrayView< int const >::value_type >::type > tmparr3 ; + Teuchos::ArrayView< int const > tmpview3 ; Teuchos::ArrayView< double const > tmparr4 ; int result; + { + arg5 = false; + } smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); arg1 = smartarg1 ? const_cast< Tpetra::CrsMatrix* >(smartarg1->get()) : NULL; - arg2 = static_cast< long long >(*farg2); - tmparr3 = Teuchos::ArrayView(static_cast(farg3->data), farg3->size); - arg3 = &tmparr3; + arg2 = *farg2 - 1; + tmpbegin3 = static_cast::value_type*>(farg3->data); + tmparr3.resize(farg3->size); + for (int i = 0; i < tmparr3.size(); i++) + tmparr3[i] = tmpbegin3[i] - 1; + tmpview3 = tmparr3(); + arg3 = &tmpview3; tmparr4 = Teuchos::ArrayView(static_cast(farg4->data), farg4->size); arg4 = &tmparr4; { // Make sure no unhandled exceptions exist before performing a new action - SWIG_check_unhandled_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::replaceGlobalValues(long long const,Teuchos::ArrayView< long long const > const &,Teuchos::ArrayView< double const > const &) const");; + SWIG_check_unhandled_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::sumIntoLocalValues(int const,Teuchos::ArrayView< int const > const &,Teuchos::ArrayView< double const > const &,bool const) const");; try { // Attempt the wrapped function call - result = (int)((Tpetra::CrsMatrix< SC,LO,GO,NO > const *)arg1)->replaceGlobalValues(arg2,(Teuchos::ArrayView< long long const > const &)*arg3,(Teuchos::ArrayView< double const > const &)*arg4); + result = (int)((Tpetra::CrsMatrix< SC,LO,GO,NO > const *)arg1)->sumIntoLocalValues(arg2,(Teuchos::ArrayView< int const > const &)*arg3,(Teuchos::ArrayView< double const > const &)*arg4,arg5); } catch (const std::range_error& e) { // Store a C++ exception - SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::replaceGlobalValues(long long const,Teuchos::ArrayView< long long const > const &,Teuchos::ArrayView< double const > const &) const", SWIG_IndexError, e.what(), return 0); + SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::sumIntoLocalValues(int const,Teuchos::ArrayView< int const > const &,Teuchos::ArrayView< double const > const &,bool const) const", SWIG_IndexError, e.what(), return 0); } catch (const std::exception& e) { // Store a C++ exception - SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::replaceGlobalValues(long long const,Teuchos::ArrayView< long long const > const &,Teuchos::ArrayView< double const > const &) const", SWIG_RuntimeError, e.what(), return 0); + SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::sumIntoLocalValues(int const,Teuchos::ArrayView< int const > const &,Teuchos::ArrayView< double const > const &,bool const) const", SWIG_RuntimeError, e.what(), return 0); } catch (...) { - SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::replaceGlobalValues(long long const,Teuchos::ArrayView< long long const > const &,Teuchos::ArrayView< double const > const &) const", SWIG_UnknownError, "An unknown exception occurred", return 0); + SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::sumIntoLocalValues(int const,Teuchos::ArrayView< int const > const &,Teuchos::ArrayView< double const > const &,bool const) const", SWIG_UnknownError, "An unknown exception occurred", return 0); } } fresult = static_cast< int >(result); @@ -12537,6 +12918,53 @@ SWIGEXPORT void _wrap_TpetraCrsMatrix_getGlobalRowCopy(SwigClassWrapper const *f } +SWIGEXPORT void _wrap_TpetraCrsMatrix_getLocalRowCopy(SwigClassWrapper const *farg1, int const *farg2, SwigArrayWrapper *farg3, SwigArrayWrapper *farg4, size_t *farg5) { + Tpetra::CrsMatrix< SC,LO,GO,NO > *arg1 = (Tpetra::CrsMatrix< SC,LO,GO,NO > *) 0 ; + int arg2 ; + Teuchos::ArrayView< int > *arg3 = 0 ; + Teuchos::ArrayView< double > *arg4 = 0 ; + size_t *arg5 = 0 ; + Teuchos::RCP< Tpetra::CrsMatrix< SC,LO,GO,NO > const > *smartarg1 ; + Teuchos::ArrayView< int > tmparr3 ; + Teuchos::ArrayView< double > tmparr4 ; + + smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::CrsMatrix* >(smartarg1->get()) : NULL; + arg2 = *farg2 - 1; + tmparr3 = Teuchos::ArrayView(static_cast(farg3->data), farg3->size); + arg3 = &tmparr3; + tmparr4 = Teuchos::ArrayView(static_cast(farg4->data), farg4->size); + arg4 = &tmparr4; + arg5 = reinterpret_cast< size_t * >(farg5); + { + // Make sure no unhandled exceptions exist before performing a new action + SWIG_check_unhandled_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::getLocalRowCopy(int,Teuchos::ArrayView< int > const &,Teuchos::ArrayView< double > const &,size_t &) const");; + try + { + // Attempt the wrapped function call + ((Tpetra::CrsMatrix< SC,LO,GO,NO > const *)arg1)->getLocalRowCopy(arg2,(Teuchos::ArrayView< int > const &)*arg3,(Teuchos::ArrayView< double > const &)*arg4,*arg5); + } + catch (const std::range_error& e) + { + // Store a C++ exception + SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::getLocalRowCopy(int,Teuchos::ArrayView< int > const &,Teuchos::ArrayView< double > const &,size_t &) const", SWIG_IndexError, e.what(), return ); + } + catch (const std::exception& e) + { + // Store a C++ exception + SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::getLocalRowCopy(int,Teuchos::ArrayView< int > const &,Teuchos::ArrayView< double > const &,size_t &) const", SWIG_RuntimeError, e.what(), return ); + } + catch (...) + { + SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::getLocalRowCopy(int,Teuchos::ArrayView< int > const &,Teuchos::ArrayView< double > const &,size_t &) const", SWIG_UnknownError, "An unknown exception occurred", return ); + } + } + + for (int i = 0; i < tmparr3.size(); i++) + tmparr3[i] += 1; +} + + SWIGEXPORT void _wrap_TpetraCrsMatrix_getGlobalRowView(SwigClassWrapper const *farg1, long long const *farg2, SwigClassWrapper const *farg3, SwigClassWrapper const *farg4) { Tpetra::CrsMatrix< SC,LO,GO,NO > *arg1 = (Tpetra::CrsMatrix< SC,LO,GO,NO > *) 0 ; long long arg2 ; @@ -13830,87 +14258,6 @@ SWIGEXPORT SwigClassWrapper _wrap_new_TpetraCrsMatrix__SWIG_17(SwigClassWrapper } -SWIGEXPORT void _wrap_TpetraCrsMatrix_insertLocalValues(SwigClassWrapper const *farg1, int const *farg2, SwigArrayWrapper *farg3, SwigArrayWrapper *farg4) { - Tpetra::CrsMatrix< SC,LO,GO,NO > *arg1 = (Tpetra::CrsMatrix< SC,LO,GO,NO > *) 0 ; - LO arg2 ; - Teuchos::ArrayView< LO const > arg3 ; - Teuchos::ArrayView< SC const > arg4 ; - Teuchos::RCP< Tpetra::CrsMatrix< SC,LO,GO,NO > > *smartarg1 ; - - smartarg1 = static_cast< Teuchos::RCP< Tpetra::CrsMatrix >* >(farg1->cptr); - arg1 = smartarg1 ? const_cast< Tpetra::CrsMatrix* >(smartarg1->get()) : NULL; - arg2 = *farg2 - 1; - arg3 = Teuchos::ArrayView(static_cast(farg3->data), farg3->size); - arg4 = Teuchos::ArrayView(static_cast(farg4->data), farg4->size); - { - // Make sure no unhandled exceptions exist before performing a new action - SWIG_check_unhandled_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::insertLocalValues(LO const,Teuchos::ArrayView< LO const >,Teuchos::ArrayView< SC const >)");; - try - { - // Attempt the wrapped function call - Tpetra_CrsMatrix_Sl_SC_Sc_LO_Sc_GO_Sc_NO_Sg__insertLocalValues(arg1,arg2,arg3,arg4); - } - catch (const std::range_error& e) - { - // Store a C++ exception - SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::insertLocalValues(LO const,Teuchos::ArrayView< LO const >,Teuchos::ArrayView< SC const >)", SWIG_IndexError, e.what(), return ); - } - catch (const std::exception& e) - { - // Store a C++ exception - SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::insertLocalValues(LO const,Teuchos::ArrayView< LO const >,Teuchos::ArrayView< SC const >)", SWIG_RuntimeError, e.what(), return ); - } - catch (...) - { - SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::insertLocalValues(LO const,Teuchos::ArrayView< LO const >,Teuchos::ArrayView< SC const >)", SWIG_UnknownError, "An unknown exception occurred", return ); - } - } - -} - - -SWIGEXPORT int _wrap_TpetraCrsMatrix_sumIntoGlobalValues(SwigClassWrapper const *farg1, long long const *farg2, SwigArrayWrapper *farg3, SwigArrayWrapper *farg4) { - int fresult ; - Tpetra::CrsMatrix< SC,LO,GO,NO > *arg1 = (Tpetra::CrsMatrix< SC,LO,GO,NO > *) 0 ; - GO arg2 ; - Teuchos::ArrayView< GO const > arg3 ; - Teuchos::ArrayView< SC const > arg4 ; - Teuchos::RCP< Tpetra::CrsMatrix< SC,LO,GO,NO > > *smartarg1 ; - LO result; - - smartarg1 = static_cast< Teuchos::RCP< Tpetra::CrsMatrix >* >(farg1->cptr); - arg1 = smartarg1 ? const_cast< Tpetra::CrsMatrix* >(smartarg1->get()) : NULL; - arg2 = static_cast< GO >(*farg2); - arg3 = Teuchos::ArrayView(static_cast(farg3->data), farg3->size); - arg4 = Teuchos::ArrayView(static_cast(farg4->data), farg4->size); - { - // Make sure no unhandled exceptions exist before performing a new action - SWIG_check_unhandled_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::sumIntoGlobalValues(GO const,Teuchos::ArrayView< GO const >,Teuchos::ArrayView< SC const >)");; - try - { - // Attempt the wrapped function call - result = (LO)Tpetra_CrsMatrix_Sl_SC_Sc_LO_Sc_GO_Sc_NO_Sg__sumIntoGlobalValues(arg1,arg2,arg3,arg4); - } - catch (const std::range_error& e) - { - // Store a C++ exception - SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::sumIntoGlobalValues(GO const,Teuchos::ArrayView< GO const >,Teuchos::ArrayView< SC const >)", SWIG_IndexError, e.what(), return 0); - } - catch (const std::exception& e) - { - // Store a C++ exception - SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::sumIntoGlobalValues(GO const,Teuchos::ArrayView< GO const >,Teuchos::ArrayView< SC const >)", SWIG_RuntimeError, e.what(), return 0); - } - catch (...) - { - SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::sumIntoGlobalValues(GO const,Teuchos::ArrayView< GO const >,Teuchos::ArrayView< SC const >)", SWIG_UnknownError, "An unknown exception occurred", return 0); - } - } - fresult = static_cast< LO >(result); - return fresult; -} - - SWIGEXPORT void _wrap_TpetraCrsMatrix_setAllValues(SwigClassWrapper const *farg1, SwigArrayWrapper *farg2, SwigArrayWrapper *farg3, SwigArrayWrapper *farg4) { Tpetra::CrsMatrix< SC,LO,GO,NO > *arg1 = (Tpetra::CrsMatrix< SC,LO,GO,NO > *) 0 ; Teuchos::ArrayView< std::size_t > arg2 ; @@ -13989,47 +14336,6 @@ SWIGEXPORT void _wrap_TpetraCrsMatrix_getAllValues(SwigClassWrapper const *farg1 } -SWIGEXPORT void _wrap_TpetraCrsMatrix_getLocalRowCopy(SwigClassWrapper const *farg1, int const *farg2, SwigArrayWrapper *farg3, SwigArrayWrapper *farg4, size_t *farg5) { - Tpetra::CrsMatrix< SC,LO,GO,NO > *arg1 = (Tpetra::CrsMatrix< SC,LO,GO,NO > *) 0 ; - LO arg2 ; - Teuchos::ArrayView< LO > arg3 ; - Teuchos::ArrayView< SC > arg4 ; - size_t *arg5 = 0 ; - Teuchos::RCP< Tpetra::CrsMatrix< SC,LO,GO,NO > const > *smartarg1 ; - - smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); - arg1 = smartarg1 ? const_cast< Tpetra::CrsMatrix* >(smartarg1->get()) : NULL; - arg2 = *farg2 - 1; - arg3 = Teuchos::ArrayView(static_cast(farg3->data), farg3->size); - arg4 = Teuchos::ArrayView(static_cast(farg4->data), farg4->size); - arg5 = reinterpret_cast< size_t * >(farg5); - { - // Make sure no unhandled exceptions exist before performing a new action - SWIG_check_unhandled_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::getLocalRowCopy(LO,Teuchos::ArrayView< LO >,Teuchos::ArrayView< SC >,size_t &) const");; - try - { - // Attempt the wrapped function call - Tpetra_CrsMatrix_Sl_SC_Sc_LO_Sc_GO_Sc_NO_Sg__getLocalRowCopy((Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const *)arg1,arg2,arg3,arg4,*arg5); - } - catch (const std::range_error& e) - { - // Store a C++ exception - SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::getLocalRowCopy(LO,Teuchos::ArrayView< LO >,Teuchos::ArrayView< SC >,size_t &) const", SWIG_IndexError, e.what(), return ); - } - catch (const std::exception& e) - { - // Store a C++ exception - SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::getLocalRowCopy(LO,Teuchos::ArrayView< LO >,Teuchos::ArrayView< SC >,size_t &) const", SWIG_RuntimeError, e.what(), return ); - } - catch (...) - { - SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::getLocalRowCopy(LO,Teuchos::ArrayView< LO >,Teuchos::ArrayView< SC >,size_t &) const", SWIG_UnknownError, "An unknown exception occurred", return ); - } - } - -} - - SWIGEXPORT void _wrap_TpetraCrsMatrix_doImport__SWIG_0(SwigClassWrapper const *farg1, SwigClassWrapper const *farg2, SwigClassWrapper const *farg3, int const *farg4) { Tpetra::CrsMatrix< SC,LO,GO,NO > *arg1 = (Tpetra::CrsMatrix< SC,LO,GO,NO > *) 0 ; Tpetra::CrsMatrix< SC,LO,GO,NO > *arg2 = 0 ; From f1af717c52eac7d5fcdfd5bf902e5903638af687 Mon Sep 17 00:00:00 2001 From: Seth R Johnson Date: Mon, 4 Feb 2019 09:59:15 -0500 Subject: [PATCH 17/40] Change eigen_handle result to 'int' from 'size_t' --- src/interface/src/eigen_handle.cpp | 6 +++--- src/interface/src/eigen_handle.hpp | 2 +- src/interface/src/swig/fortrilinos.F90 | 8 ++++---- src/interface/src/swig/fortrilinosFORTRAN_wrap.cxx | 10 +++++----- src/interface/test/test_eigen_handle.F90 | 6 ++---- 5 files changed, 15 insertions(+), 17 deletions(-) diff --git a/src/interface/src/eigen_handle.cpp b/src/interface/src/eigen_handle.cpp index fb2dfaa7..f2054e48 100644 --- a/src/interface/src/eigen_handle.cpp +++ b/src/interface/src/eigen_handle.cpp @@ -128,9 +128,9 @@ namespace ForTrilinos { status_ = SOLVER_SETUP; } - size_t TrilinosEigenSolver::solve(std::pair eigenValues, - Teuchos::RCP& eigenVectors, - std::pair eigenIndex) const { + int TrilinosEigenSolver::solve(std::pair eigenValues, + Teuchos::RCP& eigenVectors, + std::pair eigenIndex) const { using Teuchos::RCP; using Teuchos::ArrayRCP; diff --git a/src/interface/src/eigen_handle.hpp b/src/interface/src/eigen_handle.hpp index e76e6d2b..097404a5 100644 --- a/src/interface/src/eigen_handle.hpp +++ b/src/interface/src/eigen_handle.hpp @@ -61,7 +61,7 @@ namespace ForTrilinos { void setup_solver(const Teuchos::RCP& paramList); // Solve eigen system given rhs - size_t solve(std::pair eigenValues, + int solve(std::pair eigenValues, Teuchos::RCP& eigenVectors, std::pair eigenIndex) const; diff --git a/src/interface/src/swig/fortrilinos.F90 b/src/interface/src/swig/fortrilinos.F90 index 750455d5..5aacbe7b 100644 --- a/src/interface/src/swig/fortrilinos.F90 +++ b/src/interface/src/swig/fortrilinos.F90 @@ -300,7 +300,7 @@ function swigc_TrilinosEigenSolver_solve(farg1, farg2, farg3, farg4) & type(SwigArrayWrapper) :: farg2 type(SwigClassWrapper) :: farg3 type(SwigArrayWrapper) :: farg4 -integer(C_SIZE_T) :: fresult +integer(C_INT) :: fresult end function subroutine swigc_TrilinosEigenSolver_finalize(farg1) & @@ -779,7 +779,7 @@ subroutine swigf_TrilinosEigenSolver_setup_solver(self, paramlist) function swigf_TrilinosEigenSolver_solve(self, eigenvalues, eigenvectors, eigenindex) & result(swig_result) use, intrinsic :: ISO_C_BINDING -integer(C_SIZE_T) :: swig_result +integer :: swig_result class(TrilinosEigenSolver), intent(in) :: self real(C_DOUBLE), dimension(:), target :: eigenvalues @@ -789,7 +789,7 @@ function swigf_TrilinosEigenSolver_solve(self, eigenvalues, eigenvectors, eigeni integer(C_INT), dimension(:), target :: eigenindex integer(C_INT), pointer :: farg4_view -integer(C_SIZE_T) :: fresult +integer(C_INT) :: fresult type(SwigClassWrapper) :: farg1 type(SwigArrayWrapper) :: farg2 type(SwigClassWrapper) :: farg3 @@ -804,7 +804,7 @@ function swigf_TrilinosEigenSolver_solve(self, eigenvalues, eigenvectors, eigeni farg4%data = c_loc(farg4_view) farg4%size = size(eigenindex) fresult = swigc_TrilinosEigenSolver_solve(farg1, farg2, farg3, farg4) -swig_result = fresult +swig_result = int(fresult) end function subroutine swigf_TrilinosEigenSolver_finalize(self) diff --git a/src/interface/src/swig/fortrilinosFORTRAN_wrap.cxx b/src/interface/src/swig/fortrilinosFORTRAN_wrap.cxx index 53a2e2b6..e5468ffd 100644 --- a/src/interface/src/swig/fortrilinosFORTRAN_wrap.cxx +++ b/src/interface/src/swig/fortrilinosFORTRAN_wrap.cxx @@ -1326,14 +1326,14 @@ SWIGEXPORT void _wrap_TrilinosEigenSolver_setup_solver(SwigClassWrapper const *f } -SWIGEXPORT size_t _wrap_TrilinosEigenSolver_solve(SwigClassWrapper const *farg1, SwigArrayWrapper *farg2, SwigClassWrapper const *farg3, SwigArrayWrapper *farg4) { - size_t fresult ; +SWIGEXPORT int _wrap_TrilinosEigenSolver_solve(SwigClassWrapper const *farg1, SwigArrayWrapper *farg2, SwigClassWrapper const *farg3, SwigArrayWrapper *farg4) { + int fresult ; ForTrilinos::TrilinosEigenSolver *arg1 = (ForTrilinos::TrilinosEigenSolver *) 0 ; std::pair< ForTrilinos::TrilinosEigenSolver::SC *,std::size_t > arg2 ; Teuchos::RCP< ForTrilinos::TrilinosEigenSolver::MultiVector > *arg3 = 0 ; std::pair< int *,std::size_t > arg4 ; Teuchos::RCP< ForTrilinos::TrilinosEigenSolver::MultiVector > tempnull3 ; - size_t result; + int result; SWIG_check_nonnull(*farg1, "ForTrilinos::TrilinosEigenSolver const *", "TrilinosEigenSolver", "ForTrilinos::TrilinosEigenSolver::solve(std::pair< ForTrilinos::TrilinosEigenSolver::SC *,std::size_t >,Teuchos::RCP< ForTrilinos::TrilinosEigenSolver::MultiVector > &,std::pair< int *,std::size_t >) const", return 0); arg1 = static_cast< ForTrilinos::TrilinosEigenSolver * >(farg1->cptr); @@ -1348,7 +1348,7 @@ SWIGEXPORT size_t _wrap_TrilinosEigenSolver_solve(SwigClassWrapper const *farg1, try { // Attempt the wrapped function call - result = (size_t)((ForTrilinos::TrilinosEigenSolver const *)arg1)->solve(arg2,*arg3,arg4); + result = (int)((ForTrilinos::TrilinosEigenSolver const *)arg1)->solve(arg2,*arg3,arg4); } catch (const std::range_error& e) { @@ -1365,7 +1365,7 @@ SWIGEXPORT size_t _wrap_TrilinosEigenSolver_solve(SwigClassWrapper const *farg1, SWIG_exception_impl("ForTrilinos::TrilinosEigenSolver::solve(std::pair< ForTrilinos::TrilinosEigenSolver::SC *,std::size_t >,Teuchos::RCP< ForTrilinos::TrilinosEigenSolver::MultiVector > &,std::pair< int *,std::size_t >) const", SWIG_UnknownError, "An unknown exception occurred", return 0); } } - fresult = static_cast< size_t >(result); + fresult = static_cast< int >(result); return fresult; } diff --git a/src/interface/test/test_eigen_handle.F90 b/src/interface/test/test_eigen_handle.F90 index 24e5eb42..f0256b56 100644 --- a/src/interface/test/test_eigen_handle.F90 +++ b/src/interface/test/test_eigen_handle.F90 @@ -27,8 +27,7 @@ program main integer(global_size_type) :: n_global integer:: i, n integer(size_type) :: max_entries_per_row - integer(size_type) :: num_eigen = 1, num_found_eigen - integer(int_type) :: num_eigen_int + integer :: num_eigen = 1, num_found_eigen integer(int_type) :: row_nnz integer :: ierr @@ -70,8 +69,7 @@ program main plist = ParameterList("Anasazi"); FORTRILINOS_CHECK_IERR() call load_from_xml(plist, "davidson.xml"); FORTRILINOS_CHECK_IERR() - num_eigen_int = num_eigen - call plist%set("NumEV", num_eigen_int); FORTRILINOS_CHECK_IERR() + call plist%set("NumEV", num_eigen); FORTRILINOS_CHECK_IERR() ! ------------------------------------------------------------------ ! Step 0: Construct tri-diagonal matrix From e51004558fe89b023e84d89ca32aee9b7ea8ab9d Mon Sep 17 00:00:00 2001 From: Seth R Johnson Date: Mon, 4 Feb 2019 10:05:29 -0500 Subject: [PATCH 18/40] Change interface from std::pair to ArrayView --- src/interface/src/eigen_handle.cpp | 14 +++--- src/interface/src/eigen_handle.hpp | 6 +-- .../src/swig/fortrilinosFORTRAN_wrap.cxx | 20 ++++---- src/interface/test/test_eigen_handle.cpp | 2 +- .../test/test_eigen_handle_preset.cpp | 2 +- src/teuchos/src/forteuchos.i | 7 --- .../src/swig/forteuchosFORTRAN_wrap.cxx | 48 +++++++------------ 7 files changed, 39 insertions(+), 60 deletions(-) diff --git a/src/interface/src/eigen_handle.cpp b/src/interface/src/eigen_handle.cpp index f2054e48..efeb57c6 100644 --- a/src/interface/src/eigen_handle.cpp +++ b/src/interface/src/eigen_handle.cpp @@ -128,9 +128,9 @@ namespace ForTrilinos { status_ = SOLVER_SETUP; } - int TrilinosEigenSolver::solve(std::pair eigenValues, + int TrilinosEigenSolver::solve(Teuchos::ArrayView eigenValues, Teuchos::RCP& eigenVectors, - std::pair eigenIndex) const { + Teuchos::ArrayView eigenIndex) const { using Teuchos::RCP; using Teuchos::ArrayRCP; @@ -148,18 +148,18 @@ namespace ForTrilinos { std::vector& eIndex = solution.index; size_t numConverged = std::min(eNum, numEigenvalues_); - TEUCHOS_TEST_FOR_EXCEPTION(eigenValues.second < numConverged, std::runtime_error, + TEUCHOS_TEST_FOR_EXCEPTION(eigenValues.size() < numConverged, std::runtime_error, "Insufficient space to store eigenvalues. Please provide at least two times the desired number of eigenvalues."); - TEUCHOS_TEST_FOR_EXCEPTION(eigenIndex.second < numConverged, std::runtime_error, + TEUCHOS_TEST_FOR_EXCEPTION(eigenIndex.size() < numConverged, std::runtime_error, "Insufficient space to store index. Please provide at least two times the desired number of eigenvalues."); for (size_t i = 0; i < eValues.size(); i++) { - eigenValues.first[2*i+0] = eValues[i].realpart; - eigenValues.first[2*i+1] = eValues[i].imagpart; + eigenValues[2*i+0] = eValues[i].realpart; + eigenValues[2*i+1] = eValues[i].imagpart; } for (size_t i = 0; i < eIndex.size(); i++) - eigenIndex.first[i] = eIndex[i]; + eigenIndex[i] = eIndex[i]; eigenVectors = solution.Evecs; diff --git a/src/interface/src/eigen_handle.hpp b/src/interface/src/eigen_handle.hpp index 097404a5..62e5ec22 100644 --- a/src/interface/src/eigen_handle.hpp +++ b/src/interface/src/eigen_handle.hpp @@ -61,9 +61,9 @@ namespace ForTrilinos { void setup_solver(const Teuchos::RCP& paramList); // Solve eigen system given rhs - int solve(std::pair eigenValues, - Teuchos::RCP& eigenVectors, - std::pair eigenIndex) const; + int solve(Teuchos::ArrayView eigenValues, + Teuchos::RCP& eigenVectors, + Teuchos::ArrayView eigenIndex) const; // Free all data void finalize(); diff --git a/src/interface/src/swig/fortrilinosFORTRAN_wrap.cxx b/src/interface/src/swig/fortrilinosFORTRAN_wrap.cxx index e5468ffd..dbd90f0a 100644 --- a/src/interface/src/swig/fortrilinosFORTRAN_wrap.cxx +++ b/src/interface/src/swig/fortrilinosFORTRAN_wrap.cxx @@ -1329,22 +1329,20 @@ SWIGEXPORT void _wrap_TrilinosEigenSolver_setup_solver(SwigClassWrapper const *f SWIGEXPORT int _wrap_TrilinosEigenSolver_solve(SwigClassWrapper const *farg1, SwigArrayWrapper *farg2, SwigClassWrapper const *farg3, SwigArrayWrapper *farg4) { int fresult ; ForTrilinos::TrilinosEigenSolver *arg1 = (ForTrilinos::TrilinosEigenSolver *) 0 ; - std::pair< ForTrilinos::TrilinosEigenSolver::SC *,std::size_t > arg2 ; + Teuchos::ArrayView< ForTrilinos::TrilinosEigenSolver::SC > arg2 ; Teuchos::RCP< ForTrilinos::TrilinosEigenSolver::MultiVector > *arg3 = 0 ; - std::pair< int *,std::size_t > arg4 ; + Teuchos::ArrayView< int > arg4 ; Teuchos::RCP< ForTrilinos::TrilinosEigenSolver::MultiVector > tempnull3 ; int result; - SWIG_check_nonnull(*farg1, "ForTrilinos::TrilinosEigenSolver const *", "TrilinosEigenSolver", "ForTrilinos::TrilinosEigenSolver::solve(std::pair< ForTrilinos::TrilinosEigenSolver::SC *,std::size_t >,Teuchos::RCP< ForTrilinos::TrilinosEigenSolver::MultiVector > &,std::pair< int *,std::size_t >) const", return 0); + SWIG_check_nonnull(*farg1, "ForTrilinos::TrilinosEigenSolver const *", "TrilinosEigenSolver", "ForTrilinos::TrilinosEigenSolver::solve(Teuchos::ArrayView< ForTrilinos::TrilinosEigenSolver::SC >,Teuchos::RCP< ForTrilinos::TrilinosEigenSolver::MultiVector > &,Teuchos::ArrayView< int >) const", return 0); arg1 = static_cast< ForTrilinos::TrilinosEigenSolver * >(farg1->cptr); - (&arg2)->first = static_cast(farg2->data); - (&arg2)->second = farg2->size; + arg2 = Teuchos::ArrayView(static_cast(farg2->data), farg2->size); arg3 = farg3->cptr ? static_cast< Teuchos::RCP< ForTrilinos::TrilinosEigenSolver::MultiVector > * >(farg3->cptr) : &tempnull3; - (&arg4)->first = static_cast(farg4->data); - (&arg4)->second = farg4->size; + arg4 = Teuchos::ArrayView(static_cast(farg4->data), farg4->size); { // Make sure no unhandled exceptions exist before performing a new action - SWIG_check_unhandled_exception_impl("ForTrilinos::TrilinosEigenSolver::solve(std::pair< ForTrilinos::TrilinosEigenSolver::SC *,std::size_t >,Teuchos::RCP< ForTrilinos::TrilinosEigenSolver::MultiVector > &,std::pair< int *,std::size_t >) const");; + SWIG_check_unhandled_exception_impl("ForTrilinos::TrilinosEigenSolver::solve(Teuchos::ArrayView< ForTrilinos::TrilinosEigenSolver::SC >,Teuchos::RCP< ForTrilinos::TrilinosEigenSolver::MultiVector > &,Teuchos::ArrayView< int >) const");; try { // Attempt the wrapped function call @@ -1353,16 +1351,16 @@ SWIGEXPORT int _wrap_TrilinosEigenSolver_solve(SwigClassWrapper const *farg1, Sw catch (const std::range_error& e) { // Store a C++ exception - SWIG_exception_impl("ForTrilinos::TrilinosEigenSolver::solve(std::pair< ForTrilinos::TrilinosEigenSolver::SC *,std::size_t >,Teuchos::RCP< ForTrilinos::TrilinosEigenSolver::MultiVector > &,std::pair< int *,std::size_t >) const", SWIG_IndexError, e.what(), return 0); + SWIG_exception_impl("ForTrilinos::TrilinosEigenSolver::solve(Teuchos::ArrayView< ForTrilinos::TrilinosEigenSolver::SC >,Teuchos::RCP< ForTrilinos::TrilinosEigenSolver::MultiVector > &,Teuchos::ArrayView< int >) const", SWIG_IndexError, e.what(), return 0); } catch (const std::exception& e) { // Store a C++ exception - SWIG_exception_impl("ForTrilinos::TrilinosEigenSolver::solve(std::pair< ForTrilinos::TrilinosEigenSolver::SC *,std::size_t >,Teuchos::RCP< ForTrilinos::TrilinosEigenSolver::MultiVector > &,std::pair< int *,std::size_t >) const", SWIG_RuntimeError, e.what(), return 0); + SWIG_exception_impl("ForTrilinos::TrilinosEigenSolver::solve(Teuchos::ArrayView< ForTrilinos::TrilinosEigenSolver::SC >,Teuchos::RCP< ForTrilinos::TrilinosEigenSolver::MultiVector > &,Teuchos::ArrayView< int >) const", SWIG_RuntimeError, e.what(), return 0); } catch (...) { - SWIG_exception_impl("ForTrilinos::TrilinosEigenSolver::solve(std::pair< ForTrilinos::TrilinosEigenSolver::SC *,std::size_t >,Teuchos::RCP< ForTrilinos::TrilinosEigenSolver::MultiVector > &,std::pair< int *,std::size_t >) const", SWIG_UnknownError, "An unknown exception occurred", return 0); + SWIG_exception_impl("ForTrilinos::TrilinosEigenSolver::solve(Teuchos::ArrayView< ForTrilinos::TrilinosEigenSolver::SC >,Teuchos::RCP< ForTrilinos::TrilinosEigenSolver::MultiVector > &,Teuchos::ArrayView< int >) const", SWIG_UnknownError, "An unknown exception occurred", return 0); } } fresult = static_cast< int >(result); diff --git a/src/interface/test/test_eigen_handle.cpp b/src/interface/test/test_eigen_handle.cpp index d4c4d304..d5b5a5a5 100644 --- a/src/interface/test/test_eigen_handle.cpp +++ b/src/interface/test/test_eigen_handle.cpp @@ -90,7 +90,7 @@ int main(int argc, char *argv[]) { handle.setup_solver(Teuchos::rcpFromRef(paramList)); // Step 4: solve the system - handle.solve(std::make_pair(evalues.data(), 1), X, std::make_pair(eindex.data(), 1)); + handle.solve(Teuchos::arrayViewFromVector(evalues), X, Teuchos::arrayViewFromVector(eindex)); // TODO: Check the solution diff --git a/src/interface/test/test_eigen_handle_preset.cpp b/src/interface/test/test_eigen_handle_preset.cpp index 6ef35478..37ec0293 100644 --- a/src/interface/test/test_eigen_handle_preset.cpp +++ b/src/interface/test/test_eigen_handle_preset.cpp @@ -60,7 +60,7 @@ int main(int argc, char *argv[]) { handle.setup_solver(Teuchos::rcpFromRef(paramList)); // Step 4: solve the system - handle.solve(std::make_pair(evalues.data(), 1), X, std::make_pair(eindex.data(), 1)); + handle.solve(Teuchos::arrayViewFromVector(evalues), X, Teuchos::arrayViewFromVector(eindex)); // TODO: Check the solution diff --git a/src/teuchos/src/forteuchos.i b/src/teuchos/src/forteuchos.i index 1985ae2d..31bd3d99 100644 --- a/src/teuchos/src/forteuchos.i +++ b/src/teuchos/src/forteuchos.i @@ -23,13 +23,6 @@ typedef int Teuchos_Ordinal; %typemap(fin) int "$1 = int($input, C_INT)" %typemap(fout) int "$result = int($1)" -// pair typemaps: (TODO: these should be deprecated) -%include -%fortran_view(int) -%fortran_view(long long) -%fortran_view(double) -%fortran_view(size_t) - // Convert all std::string references/values to and from Fortran strings %include diff --git a/src/teuchos/src/swig/forteuchosFORTRAN_wrap.cxx b/src/teuchos/src/swig/forteuchosFORTRAN_wrap.cxx index add0907e..b117b965 100644 --- a/src/teuchos/src/swig/forteuchosFORTRAN_wrap.cxx +++ b/src/teuchos/src/swig/forteuchosFORTRAN_wrap.cxx @@ -205,21 +205,6 @@ void SWIG_store_exception(const char* decl, int errcode, const char *msg); SWIG_store_exception(DECL, CODE, MSG); RETURNNULL; -namespace swig { - -enum AssignmentFlags { - IS_DESTR = 0x01, - IS_COPY_CONSTR = 0x02, - IS_COPY_ASSIGN = 0x04, - IS_MOVE_CONSTR = 0x08, - IS_MOVE_ASSIGN = 0x10 -}; - -template -struct assignment_flags; -} - - #define SWIG_check_mutable(SWIG_CLASS_WRAPPER, TYPENAME, FNAME, FUNCNAME, RETURNNULL) \ if ((SWIG_CLASS_WRAPPER).mem == SWIG_CREF) { \ SWIG_exception_impl(FUNCNAME, SWIG_TypeError, \ @@ -242,6 +227,21 @@ struct assignment_flags; SWIG_check_mutable(SWIG_CLASS_WRAPPER, TYPENAME, FNAME, FUNCNAME, RETURNNULL); +namespace swig { + +enum AssignmentFlags { + IS_DESTR = 0x01, + IS_COPY_CONSTR = 0x02, + IS_COPY_ASSIGN = 0x04, + IS_MOVE_CONSTR = 0x08, + IS_MOVE_ASSIGN = 0x10 +}; + +template +struct assignment_flags; +} + + #define SWIG_assign(LEFTTYPE, LEFT, RIGHTTYPE, RIGHT, FLAGS) \ SWIG_assign_impl::value >(LEFT, RIGHT); @@ -274,21 +274,6 @@ struct assignment_flags; #define SWIG_as_voidptrptr(a) ((void)SWIG_as_voidptr(*a),reinterpret_cast< void** >(a)) -#include - - -namespace swig { -template -struct assignment_flags, Flags> { - enum { value = IS_DESTR | IS_COPY_CONSTR }; -}; -template -struct assignment_flags, Flags> { - enum { value = IS_DESTR | IS_COPY_CONSTR }; -}; -} - - #include @@ -359,6 +344,9 @@ SWIGINTERN Teuchos::ArrayView< int > Teuchos_Array_Sl_int_Sg__view(Teuchos::Arra return (*self)(); } +#include + + namespace swig { // Define our own switching struct to support pre-c++11 builds From 2400ca0f35fdb87194e2aa97f74ad52744aaadb4 Mon Sep 17 00:00:00 2001 From: Seth R Johnson Date: Mon, 4 Feb 2019 10:27:40 -0500 Subject: [PATCH 19/40] Combine Import and Export headers Gets rid of the 'FIXME' since SWIG now knows about Import when instantiating Export. --- src/tpetra/src/Tpetra_CrsGraph.i | 16 +- src/tpetra/src/Tpetra_CrsMatrix.i | 16 +- src/tpetra/src/Tpetra_Export.i | 45 - ...Tpetra_Import.i => Tpetra_Import_Export.i} | 51 + src/tpetra/src/Tpetra_MultiVector.i | 16 +- src/tpetra/src/fortpetra.i | 15 +- src/tpetra/src/swig/fortpetra.F90 | 680 +++++------- src/tpetra/src/swig/fortpetraFORTRAN_wrap.cxx | 984 +++++++----------- 8 files changed, 696 insertions(+), 1127 deletions(-) delete mode 100644 src/tpetra/src/Tpetra_Export.i rename src/tpetra/src/{Tpetra_Import.i => Tpetra_Import_Export.i} (57%) diff --git a/src/tpetra/src/Tpetra_CrsGraph.i b/src/tpetra/src/Tpetra_CrsGraph.i index 9f0ad38e..aafd5e58 100644 --- a/src/tpetra/src/Tpetra_CrsGraph.i +++ b/src/tpetra/src/Tpetra_CrsGraph.i @@ -132,19 +132,11 @@ for (int i = 0; i < nnz; i++) columnIndices[i] = columnIndicesArrayRCP[i]+1; } - void doImport (const Tpetra::CrsGraph &source, const Tpetra::Import< LO, GO, NO > &importer, CombineMode CM) { - $self->doImport(source, importer, CM); - } - void doImport (const Tpetra::CrsGraph &source, const Tpetra::Export< LO, GO, NO > &exporter, CombineMode CM) { - $self->doImport(source, exporter, CM); - } - void doExport (const Tpetra::CrsGraph &source, const Tpetra::Export< LO, GO, NO > &exporter, CombineMode CM) { - $self->doExport(source, exporter, CM); - } - void doExport (const Tpetra::CrsGraph &source, const Tpetra::Import< LO, GO, NO > &importer, CombineMode CM) { - $self->doExport(source, importer, CM); - } } + +// Add doImport and doExport +%tpetra_extend_with_import_export(Tpetra::CrsGraph) + %ignore Tpetra::CrsGraph::CrsGraph (const Teuchos::RCP< const map_type > &rowMap, const Teuchos::ArrayRCP< const size_t > &numEntPerRow, const ProfileType pftype=DynamicProfile, diff --git a/src/tpetra/src/Tpetra_CrsMatrix.i b/src/tpetra/src/Tpetra_CrsMatrix.i index 0f117e6d..da4c2122 100644 --- a/src/tpetra/src/Tpetra_CrsMatrix.i +++ b/src/tpetra/src/Tpetra_CrsMatrix.i @@ -143,19 +143,11 @@ values [i] = valuesArrayRCP[i]; } } - void doImport (const Tpetra::CrsMatrix &source, const Tpetra::Import< LO, GO, NO > &importer, CombineMode CM) { - $self->doImport(source, importer, CM); - } - void doImport (const Tpetra::CrsMatrix &source, const Tpetra::Export< LO, GO, NO > &exporter, CombineMode CM) { - $self->doImport(source, exporter, CM); - } - void doExport (const Tpetra::CrsMatrix &source, const Tpetra::Export< LO, GO, NO > &exporter, CombineMode CM) { - $self->doExport(source, exporter, CM); - } - void doExport (const Tpetra::CrsMatrix &source, const Tpetra::Import< LO, GO, NO > &importer, CombineMode CM) { - $self->doExport(source, importer, CM); - } } + +// Add doImport and doExport +%tpetra_extend_with_import_export(Tpetra::CrsGraph) + %ignore Tpetra::CrsMatrix::CrsMatrix (const Teuchos::RCP& rowMap, const Teuchos::ArrayRCP& NumEntriesPerRowToAlloc, ProfileType pftype = DynamicProfile, diff --git a/src/tpetra/src/Tpetra_Export.i b/src/tpetra/src/Tpetra_Export.i deleted file mode 100644 index 1a6b2afd..00000000 --- a/src/tpetra/src/Tpetra_Export.i +++ /dev/null @@ -1,45 +0,0 @@ -/* - * Copyright 2017-2018, UT-Battelle, LLC - * - * SPDX-License-Identifier: BSD-3-Clause - * License-Filename: LICENSE - */ - -// Dependencies -%include "Teuchos_RCP.i" - -%{ -#include "Tpetra_Export.hpp" -// !FIXME -using Tpetra::Import; -%} - -// ======================================================================= -// Ignore permanently -// ======================================================================= -// Ignore Details namespace - -// ======================================================================= -// Postpone temporarily -// ======================================================================= -%ignore Tpetra::Export::Export(const Teuchos::RCP< const map_type > &source, - const Teuchos::RCP< const map_type > &target, - const Teuchos::RCP< Teuchos::FancyOStream > &out); // needs Teuchos::FancyOStream -%ignore Tpetra::Export::Export(const Teuchos::RCP< const map_type > &source, - const Teuchos::RCP< const map_type > &target, - const Teuchos::RCP< Teuchos::FancyOStream > &out, - const Teuchos::RCP< Teuchos::ParameterList > &plist); // needs Teuchos::FancyOStream -%ignore Tpetra::Export::getPermuteFromLIDs; // ±1 issue -%ignore Tpetra::Export::getPermuteToLIDs; // ±1 issue -%ignore Tpetra::Export::getRemoteLIDs; // ±1 issue -%ignore Tpetra::Export::getExportLIDs; // ±1 issue -%ignore Tpetra::Export::getExportPIDs; // ±1 issue -%ignore Tpetra::Export::getDistributor; // needs Tpetra::Distributor -%ignore Tpetra::Export::operator=; // needs operator= -%ignore Tpetra::Export::describe; // needs Teuchos::FancyOStream -%ignore Tpetra::Export::print; // needs std::ostream - -%include "Tpetra_Export_decl.hpp" - -%teuchos_rcp(Tpetra::Export) -%template(TpetraExport) Tpetra::Export; diff --git a/src/tpetra/src/Tpetra_Import.i b/src/tpetra/src/Tpetra_Import_Export.i similarity index 57% rename from src/tpetra/src/Tpetra_Import.i rename to src/tpetra/src/Tpetra_Import_Export.i index 48fccb1a..b3baf0c7 100644 --- a/src/tpetra/src/Tpetra_Import.i +++ b/src/tpetra/src/Tpetra_Import_Export.i @@ -10,6 +10,7 @@ %{ #include "Tpetra_Import.hpp" +#include "Tpetra_Export.hpp" %} // ======================================================================= @@ -20,6 +21,23 @@ // ======================================================================= // Postpone temporarily // ======================================================================= +%ignore Tpetra::Export::Export(const Teuchos::RCP< const map_type > &source, + const Teuchos::RCP< const map_type > &target, + const Teuchos::RCP< Teuchos::FancyOStream > &out); // needs Teuchos::FancyOStream +%ignore Tpetra::Export::Export(const Teuchos::RCP< const map_type > &source, + const Teuchos::RCP< const map_type > &target, + const Teuchos::RCP< Teuchos::FancyOStream > &out, + const Teuchos::RCP< Teuchos::ParameterList > &plist); // needs Teuchos::FancyOStream +%ignore Tpetra::Export::getPermuteFromLIDs; // ±1 issue +%ignore Tpetra::Export::getPermuteToLIDs; // ±1 issue +%ignore Tpetra::Export::getRemoteLIDs; // ±1 issue +%ignore Tpetra::Export::getExportLIDs; // ±1 issue +%ignore Tpetra::Export::getExportPIDs; // ±1 issue +%ignore Tpetra::Export::getDistributor; // needs Tpetra::Distributor +%ignore Tpetra::Export::operator=; // needs operator= +%ignore Tpetra::Export::describe; // needs Teuchos::FancyOStream +%ignore Tpetra::Export::print; // needs std::ostream + %ignore Tpetra::Import::Import(const Teuchos::RCP< const map_type > &source, const Teuchos::RCP< const map_type > &target, const Teuchos::RCP< Teuchos::FancyOStream > &out); // needs Teuchos::FancyOStream @@ -58,7 +76,40 @@ %ignore Tpetra::Import::describe; // needs Teuchos::FancyOStream %ignore Tpetra::Import::print; // needs std::ostream +// ======================================================================= +// Instantiate +// ======================================================================= + +// First, declare templates %include "Tpetra_Import_decl.hpp" +%include "Tpetra_Export_decl.hpp" +// Then, label the classes as RCPs +%teuchos_rcp(Tpetra::Export) %teuchos_rcp(Tpetra::Import) + +// Finally, instantiate (since they each have the other type as constructors) %template(TpetraImport) Tpetra::Import; +%template(TpetraExport) Tpetra::Export; + +// ======================================================================= +// Macros +// ======================================================================= + +%define %tpetra_extend_with_import_export(CLS...) +%extend CLS { + void doImport (const CLS &source, const Tpetra::Import< LO, GO, NO > &importer, CombineMode CM) { + $self->doImport(source, importer, CM); + } + void doImport (const CLS &source, const Tpetra::Export< LO, GO, NO > &exporter, CombineMode CM) { + $self->doImport(source, exporter, CM); + } + void doExport (const CLS &source, const Tpetra::Export< LO, GO, NO > &exporter, CombineMode CM) { + $self->doExport(source, exporter, CM); + } + void doExport (const CLS &source, const Tpetra::Import< LO, GO, NO > &importer, CombineMode CM) { + $self->doExport(source, importer, CM); + } +} +%enddef + diff --git a/src/tpetra/src/Tpetra_MultiVector.i b/src/tpetra/src/Tpetra_MultiVector.i index 6dfaa01c..94d5ad45 100644 --- a/src/tpetra/src/Tpetra_MultiVector.i +++ b/src/tpetra/src/Tpetra_MultiVector.i @@ -65,20 +65,8 @@ %ignore Tpetra::deep_copy; %ignore Tpetra::getMultiVectorWhichVectors; -%extend Tpetra::MultiVector { - void doImport (const Tpetra::MultiVector &source, const Tpetra::Import< LO, GO, NO > &importer, CombineMode CM) { - $self->doImport(source, importer, CM); - } - void doImport (const Tpetra::MultiVector &source, const Tpetra::Export< LO, GO, NO > &exporter, CombineMode CM) { - $self->doImport(source, exporter, CM); - } - void doExport (const Tpetra::MultiVector &source, const Tpetra::Export< LO, GO, NO > &exporter, CombineMode CM) { - $self->doExport(source, exporter, CM); - } - void doExport (const Tpetra::MultiVector &source, const Tpetra::Import< LO, GO, NO > &importer, CombineMode CM) { - $self->doExport(source, importer, CM); - } -} +// Add doImport and doExport +%tpetra_extend_with_import_export(Tpetra::MultiVector) // Fix ±1 issues %apply int INDEX { size_t j, size_t col, int lclRow } diff --git a/src/tpetra/src/fortpetra.i b/src/tpetra/src/fortpetra.i index d1d85893..6c01ac94 100644 --- a/src/tpetra/src/fortpetra.i +++ b/src/tpetra/src/fortpetra.i @@ -11,6 +11,10 @@ %import +// ======================================================================= +// Type definition +// ======================================================================= + #define HAVE_TPETRA_INST_INT_LONG_LONG // From teuchos/kokkoscompat/src/KokkosCompat_ClassicNodeAPI_Wrapper.hpp %ignore KokkosSerialWrapperNode; @@ -59,6 +63,10 @@ public :: mag_type public :: norm_type } +// ======================================================================= +// Typemaps +// ======================================================================= + // Define typemap for converting Fortran indexing to C indexing %typemap(in) int INDEX "$1 = *$input - 1;" %typemap(out) int INDEX "$result = $1 + 1;" @@ -89,6 +97,10 @@ public :: norm_type tmparr$argnum[i] += 1; } +// ======================================================================= +// Wrap +// ======================================================================= + // All enums should be prefaced with Tpetra %rename("Tpetra%s", %$isenumitem) ""; %rename("Tpetra%s", %$isenum) ""; @@ -101,8 +113,7 @@ public :: norm_type // Order matters!!! %include "Tpetra_Map.i" -%include "Tpetra_Export.i" -%include "Tpetra_Import.i" +%include "Tpetra_Import_Export.i" /* %include "Tpetra_DistObject.i" */ %include "Tpetra_MultiVector.i" /* %include "Tpetra_Vector.i" */ // needs better support for inheritance diff --git a/src/tpetra/src/swig/fortpetra.F90 b/src/tpetra/src/swig/fortpetra.F90 index afb9ae8d..362933ff 100644 --- a/src/tpetra/src/swig/fortpetra.F90 +++ b/src/tpetra/src/swig/fortpetra.F90 @@ -162,31 +162,6 @@ module fortpetra module procedure new_TpetraMap__SWIG_6 module procedure new_TpetraMap__SWIG_7 end interface - type, public :: SWIGTYPE_ImportT_int_long_long_Kokkos__Compat__KokkosSeri1YW4XR - type(SwigClassWrapper), public :: swigdata - end type - ! class Tpetra::Export< LO,GO,NO > - type, public :: TpetraExport - type(SwigClassWrapper), public :: swigdata - contains - procedure :: release => delete_TpetraExport - procedure :: setParameterList => swigf_TpetraExport_setParameterList - procedure :: getNumSameIDs => swigf_TpetraExport_getNumSameIDs - procedure :: getNumPermuteIDs => swigf_TpetraExport_getNumPermuteIDs - procedure :: getNumRemoteIDs => swigf_TpetraExport_getNumRemoteIDs - procedure :: getNumExportIDs => swigf_TpetraExport_getNumExportIDs - procedure :: getSourceMap => swigf_TpetraExport_getSourceMap - procedure :: getTargetMap => swigf_TpetraExport_getTargetMap - procedure :: isLocallyComplete => swigf_TpetraExport_isLocallyComplete - procedure, private :: swigf_assignment_TpetraExport - generic :: assignment(=) => swigf_assignment_TpetraExport - end type TpetraExport - interface TpetraExport - module procedure new_TpetraExport__SWIG_0 - module procedure new_TpetraExport__SWIG_1 - module procedure new_TpetraExport__SWIG_2 - module procedure new_TpetraExport__SWIG_3 - end interface ! class Tpetra::Import< LO,GO,NO > type, public :: TpetraImport type(SwigClassWrapper), public :: swigdata @@ -213,6 +188,28 @@ module fortpetra module procedure new_TpetraImport__SWIG_2 module procedure new_TpetraImport__SWIG_3 end interface + ! class Tpetra::Export< LO,GO,NO > + type, public :: TpetraExport + type(SwigClassWrapper), public :: swigdata + contains + procedure :: release => delete_TpetraExport + procedure :: setParameterList => swigf_TpetraExport_setParameterList + procedure :: getNumSameIDs => swigf_TpetraExport_getNumSameIDs + procedure :: getNumPermuteIDs => swigf_TpetraExport_getNumPermuteIDs + procedure :: getNumRemoteIDs => swigf_TpetraExport_getNumRemoteIDs + procedure :: getNumExportIDs => swigf_TpetraExport_getNumExportIDs + procedure :: getSourceMap => swigf_TpetraExport_getSourceMap + procedure :: getTargetMap => swigf_TpetraExport_getTargetMap + procedure :: isLocallyComplete => swigf_TpetraExport_isLocallyComplete + procedure, private :: swigf_assignment_TpetraExport + generic :: assignment(=) => swigf_assignment_TpetraExport + end type TpetraExport + interface TpetraExport + module procedure new_TpetraExport__SWIG_0 + module procedure new_TpetraExport__SWIG_1 + module procedure new_TpetraExport__SWIG_2 + module procedure new_TpetraExport__SWIG_3 + end interface type, public :: SWIGTYPE_Kokkos__ViewT_double_p_Kokkos__HostSpace_t type(SwigClassWrapper), public :: swigdata end type @@ -437,7 +434,6 @@ module fortpetra procedure, private :: exportAndFillComplete__SWIG_4 => swigf_TpetraCrsGraph_exportAndFillComplete__SWIG_4 procedure :: haveGlobalConstants => swigf_TpetraCrsGraph_haveGlobalConstants procedure :: computeGlobalConstants => swigf_TpetraCrsGraph_computeGlobalConstants - procedure :: setAllIndices => swigf_TpetraCrsGraph_setAllIndices procedure :: getNodeRowPtrs => swigf_TpetraCrsGraph_getNodeRowPtrs procedure :: getNodePackedIndices => swigf_TpetraCrsGraph_getNodePackedIndices procedure, private :: doImport__SWIG_0 => swigf_TpetraCrsGraph_doImport__SWIG_0 @@ -568,17 +564,11 @@ module fortpetra procedure :: haveGlobalConstants => swigf_TpetraCrsMatrix_haveGlobalConstants procedure :: setAllValues => swigf_TpetraCrsMatrix_setAllValues procedure :: getAllValues => swigf_TpetraCrsMatrix_getAllValues - procedure, private :: doImport__SWIG_0 => swigf_TpetraCrsMatrix_doImport__SWIG_0 - procedure, private :: doImport__SWIG_1 => swigf_TpetraCrsMatrix_doImport__SWIG_1 - procedure, private :: doExport__SWIG_0 => swigf_TpetraCrsMatrix_doExport__SWIG_0 - procedure, private :: doExport__SWIG_1 => swigf_TpetraCrsMatrix_doExport__SWIG_1 procedure, private :: swigf_assignment_TpetraCrsMatrix generic :: assignment(=) => swigf_assignment_TpetraCrsMatrix generic :: reindexColumns => reindexColumns__SWIG_0, reindexColumns__SWIG_1, reindexColumns__SWIG_2 generic :: apply => apply__SWIG_0, apply__SWIG_1, apply__SWIG_2, apply__SWIG_3 - generic :: doImport => doImport__SWIG_0, doImport__SWIG_1 generic :: resumeFill => resumeFill__SWIG_0, resumeFill__SWIG_1 - generic :: doExport => doExport__SWIG_0, doExport__SWIG_1 generic :: replaceLocalValues => replaceLocalValues__SWIG_1, replaceLocalValues__SWIG_2 generic :: sumIntoGlobalValues => sumIntoGlobalValues__SWIG_0 generic :: sumIntoLocalValues => sumIntoLocalValues__SWIG_0 @@ -1085,8 +1075,8 @@ subroutine swigc_assignment_TpetraMap(self, other) & type(SwigClassWrapper), intent(inout) :: self type(SwigClassWrapper), intent(in) :: other end subroutine -function swigc_new_TpetraExport__SWIG_0(farg1, farg2) & -bind(C, name="_wrap_new_TpetraExport__SWIG_0") & +function swigc_new_TpetraImport__SWIG_0(farg1, farg2) & +bind(C, name="_wrap_new_TpetraImport__SWIG_0") & result(fresult) use, intrinsic :: ISO_C_BINDING import :: swigclasswrapper @@ -1095,8 +1085,8 @@ function swigc_new_TpetraExport__SWIG_0(farg1, farg2) & type(SwigClassWrapper) :: fresult end function -function swigc_new_TpetraExport__SWIG_1(farg1, farg2, farg3) & -bind(C, name="_wrap_new_TpetraExport__SWIG_1") & +function swigc_new_TpetraImport__SWIG_1(farg1, farg2, farg3) & +bind(C, name="_wrap_new_TpetraImport__SWIG_1") & result(fresult) use, intrinsic :: ISO_C_BINDING import :: swigclasswrapper @@ -1106,8 +1096,8 @@ function swigc_new_TpetraExport__SWIG_1(farg1, farg2, farg3) & type(SwigClassWrapper) :: fresult end function -function swigc_new_TpetraExport__SWIG_2(farg1) & -bind(C, name="_wrap_new_TpetraExport__SWIG_2") & +function swigc_new_TpetraImport__SWIG_2(farg1) & +bind(C, name="_wrap_new_TpetraImport__SWIG_2") & result(fresult) use, intrinsic :: ISO_C_BINDING import :: swigclasswrapper @@ -1115,8 +1105,8 @@ function swigc_new_TpetraExport__SWIG_2(farg1) & type(SwigClassWrapper) :: fresult end function -function swigc_new_TpetraExport__SWIG_3(farg1) & -bind(C, name="_wrap_new_TpetraExport__SWIG_3") & +function swigc_new_TpetraImport__SWIG_3(farg1) & +bind(C, name="_wrap_new_TpetraImport__SWIG_3") & result(fresult) use, intrinsic :: ISO_C_BINDING import :: swigclasswrapper @@ -1124,23 +1114,23 @@ function swigc_new_TpetraExport__SWIG_3(farg1) & type(SwigClassWrapper) :: fresult end function -subroutine swigc_delete_TpetraExport(farg1) & -bind(C, name="_wrap_delete_TpetraExport") +subroutine swigc_delete_TpetraImport(farg1) & +bind(C, name="_wrap_delete_TpetraImport") use, intrinsic :: ISO_C_BINDING import :: swigclasswrapper type(SwigClassWrapper) :: farg1 end subroutine -subroutine swigc_TpetraExport_setParameterList(farg1, farg2) & -bind(C, name="_wrap_TpetraExport_setParameterList") +subroutine swigc_TpetraImport_setParameterList(farg1, farg2) & +bind(C, name="_wrap_TpetraImport_setParameterList") use, intrinsic :: ISO_C_BINDING import :: swigclasswrapper type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 end subroutine -function swigc_TpetraExport_getNumSameIDs(farg1) & -bind(C, name="_wrap_TpetraExport_getNumSameIDs") & +function swigc_TpetraImport_getNumSameIDs(farg1) & +bind(C, name="_wrap_TpetraImport_getNumSameIDs") & result(fresult) use, intrinsic :: ISO_C_BINDING import :: swigclasswrapper @@ -1148,8 +1138,8 @@ function swigc_TpetraExport_getNumSameIDs(farg1) & integer(C_SIZE_T) :: fresult end function -function swigc_TpetraExport_getNumPermuteIDs(farg1) & -bind(C, name="_wrap_TpetraExport_getNumPermuteIDs") & +function swigc_TpetraImport_getNumPermuteIDs(farg1) & +bind(C, name="_wrap_TpetraImport_getNumPermuteIDs") & result(fresult) use, intrinsic :: ISO_C_BINDING import :: swigclasswrapper @@ -1157,8 +1147,8 @@ function swigc_TpetraExport_getNumPermuteIDs(farg1) & integer(C_SIZE_T) :: fresult end function -function swigc_TpetraExport_getNumRemoteIDs(farg1) & -bind(C, name="_wrap_TpetraExport_getNumRemoteIDs") & +function swigc_TpetraImport_getNumRemoteIDs(farg1) & +bind(C, name="_wrap_TpetraImport_getNumRemoteIDs") & result(fresult) use, intrinsic :: ISO_C_BINDING import :: swigclasswrapper @@ -1166,8 +1156,8 @@ function swigc_TpetraExport_getNumRemoteIDs(farg1) & integer(C_SIZE_T) :: fresult end function -function swigc_TpetraExport_getNumExportIDs(farg1) & -bind(C, name="_wrap_TpetraExport_getNumExportIDs") & +function swigc_TpetraImport_getNumExportIDs(farg1) & +bind(C, name="_wrap_TpetraImport_getNumExportIDs") & result(fresult) use, intrinsic :: ISO_C_BINDING import :: swigclasswrapper @@ -1175,8 +1165,8 @@ function swigc_TpetraExport_getNumExportIDs(farg1) & integer(C_SIZE_T) :: fresult end function -function swigc_TpetraExport_getSourceMap(farg1) & -bind(C, name="_wrap_TpetraExport_getSourceMap") & +function swigc_TpetraImport_getSourceMap(farg1) & +bind(C, name="_wrap_TpetraImport_getSourceMap") & result(fresult) use, intrinsic :: ISO_C_BINDING import :: swigclasswrapper @@ -1184,8 +1174,8 @@ function swigc_TpetraExport_getSourceMap(farg1) & type(SwigClassWrapper) :: fresult end function -function swigc_TpetraExport_getTargetMap(farg1) & -bind(C, name="_wrap_TpetraExport_getTargetMap") & +function swigc_TpetraImport_getTargetMap(farg1) & +bind(C, name="_wrap_TpetraImport_getTargetMap") & result(fresult) use, intrinsic :: ISO_C_BINDING import :: swigclasswrapper @@ -1193,8 +1183,8 @@ function swigc_TpetraExport_getTargetMap(farg1) & type(SwigClassWrapper) :: fresult end function -function swigc_TpetraExport_isLocallyComplete(farg1) & -bind(C, name="_wrap_TpetraExport_isLocallyComplete") & +function swigc_TpetraImport_isLocallyComplete(farg1) & +bind(C, name="_wrap_TpetraImport_isLocallyComplete") & result(fresult) use, intrinsic :: ISO_C_BINDING import :: swigclasswrapper @@ -1202,15 +1192,8 @@ function swigc_TpetraExport_isLocallyComplete(farg1) & integer(C_INT) :: fresult end function - subroutine swigc_assignment_TpetraExport(self, other) & - bind(C, name="_wrap_assign_TpetraExport") - use, intrinsic :: ISO_C_BINDING - import :: SwigClassWrapper - type(SwigClassWrapper), intent(inout) :: self - type(SwigClassWrapper), intent(in) :: other - end subroutine -function swigc_new_TpetraImport__SWIG_0(farg1, farg2) & -bind(C, name="_wrap_new_TpetraImport__SWIG_0") & +function swigc_TpetraImport_setUnion__SWIG_0(farg1, farg2) & +bind(C, name="_wrap_TpetraImport_setUnion__SWIG_0") & result(fresult) use, intrinsic :: ISO_C_BINDING import :: swigclasswrapper @@ -1219,79 +1202,88 @@ function swigc_new_TpetraImport__SWIG_0(farg1, farg2) & type(SwigClassWrapper) :: fresult end function -function swigc_new_TpetraImport__SWIG_1(farg1, farg2, farg3) & -bind(C, name="_wrap_new_TpetraImport__SWIG_1") & +function swigc_TpetraImport_setUnion__SWIG_1(farg1) & +bind(C, name="_wrap_TpetraImport_setUnion__SWIG_1") & result(fresult) use, intrinsic :: ISO_C_BINDING import :: swigclasswrapper type(SwigClassWrapper) :: farg1 -type(SwigClassWrapper) :: farg2 -type(SwigClassWrapper) :: farg3 type(SwigClassWrapper) :: fresult end function -function swigc_new_TpetraImport__SWIG_2(farg1) & -bind(C, name="_wrap_new_TpetraImport__SWIG_2") & +function swigc_TpetraImport_createRemoteOnlyImport(farg1, farg2) & +bind(C, name="_wrap_TpetraImport_createRemoteOnlyImport") & result(fresult) use, intrinsic :: ISO_C_BINDING import :: swigclasswrapper type(SwigClassWrapper) :: farg1 +type(SwigClassWrapper) :: farg2 type(SwigClassWrapper) :: fresult end function -function swigc_new_TpetraImport__SWIG_3(farg1) & -bind(C, name="_wrap_new_TpetraImport__SWIG_3") & + subroutine swigc_assignment_TpetraImport(self, other) & + bind(C, name="_wrap_assign_TpetraImport") + use, intrinsic :: ISO_C_BINDING + import :: SwigClassWrapper + type(SwigClassWrapper), intent(inout) :: self + type(SwigClassWrapper), intent(in) :: other + end subroutine +function swigc_new_TpetraExport__SWIG_0(farg1, farg2) & +bind(C, name="_wrap_new_TpetraExport__SWIG_0") & result(fresult) use, intrinsic :: ISO_C_BINDING import :: swigclasswrapper type(SwigClassWrapper) :: farg1 +type(SwigClassWrapper) :: farg2 type(SwigClassWrapper) :: fresult end function -subroutine swigc_delete_TpetraImport(farg1) & -bind(C, name="_wrap_delete_TpetraImport") +function swigc_new_TpetraExport__SWIG_1(farg1, farg2, farg3) & +bind(C, name="_wrap_new_TpetraExport__SWIG_1") & +result(fresult) use, intrinsic :: ISO_C_BINDING import :: swigclasswrapper type(SwigClassWrapper) :: farg1 -end subroutine +type(SwigClassWrapper) :: farg2 +type(SwigClassWrapper) :: farg3 +type(SwigClassWrapper) :: fresult +end function -subroutine swigc_TpetraImport_setParameterList(farg1, farg2) & -bind(C, name="_wrap_TpetraImport_setParameterList") +function swigc_new_TpetraExport__SWIG_2(farg1) & +bind(C, name="_wrap_new_TpetraExport__SWIG_2") & +result(fresult) use, intrinsic :: ISO_C_BINDING import :: swigclasswrapper type(SwigClassWrapper) :: farg1 -type(SwigClassWrapper) :: farg2 -end subroutine +type(SwigClassWrapper) :: fresult +end function -function swigc_TpetraImport_getNumSameIDs(farg1) & -bind(C, name="_wrap_TpetraImport_getNumSameIDs") & +function swigc_new_TpetraExport__SWIG_3(farg1) & +bind(C, name="_wrap_new_TpetraExport__SWIG_3") & result(fresult) use, intrinsic :: ISO_C_BINDING import :: swigclasswrapper type(SwigClassWrapper) :: farg1 -integer(C_SIZE_T) :: fresult +type(SwigClassWrapper) :: fresult end function -function swigc_TpetraImport_getNumPermuteIDs(farg1) & -bind(C, name="_wrap_TpetraImport_getNumPermuteIDs") & -result(fresult) +subroutine swigc_delete_TpetraExport(farg1) & +bind(C, name="_wrap_delete_TpetraExport") use, intrinsic :: ISO_C_BINDING import :: swigclasswrapper type(SwigClassWrapper) :: farg1 -integer(C_SIZE_T) :: fresult -end function +end subroutine -function swigc_TpetraImport_getNumRemoteIDs(farg1) & -bind(C, name="_wrap_TpetraImport_getNumRemoteIDs") & -result(fresult) +subroutine swigc_TpetraExport_setParameterList(farg1, farg2) & +bind(C, name="_wrap_TpetraExport_setParameterList") use, intrinsic :: ISO_C_BINDING import :: swigclasswrapper type(SwigClassWrapper) :: farg1 -integer(C_SIZE_T) :: fresult -end function +type(SwigClassWrapper) :: farg2 +end subroutine -function swigc_TpetraImport_getNumExportIDs(farg1) & -bind(C, name="_wrap_TpetraImport_getNumExportIDs") & +function swigc_TpetraExport_getNumSameIDs(farg1) & +bind(C, name="_wrap_TpetraExport_getNumSameIDs") & result(fresult) use, intrinsic :: ISO_C_BINDING import :: swigclasswrapper @@ -1299,45 +1291,44 @@ function swigc_TpetraImport_getNumExportIDs(farg1) & integer(C_SIZE_T) :: fresult end function -function swigc_TpetraImport_getSourceMap(farg1) & -bind(C, name="_wrap_TpetraImport_getSourceMap") & +function swigc_TpetraExport_getNumPermuteIDs(farg1) & +bind(C, name="_wrap_TpetraExport_getNumPermuteIDs") & result(fresult) use, intrinsic :: ISO_C_BINDING import :: swigclasswrapper type(SwigClassWrapper) :: farg1 -type(SwigClassWrapper) :: fresult +integer(C_SIZE_T) :: fresult end function -function swigc_TpetraImport_getTargetMap(farg1) & -bind(C, name="_wrap_TpetraImport_getTargetMap") & +function swigc_TpetraExport_getNumRemoteIDs(farg1) & +bind(C, name="_wrap_TpetraExport_getNumRemoteIDs") & result(fresult) use, intrinsic :: ISO_C_BINDING import :: swigclasswrapper type(SwigClassWrapper) :: farg1 -type(SwigClassWrapper) :: fresult +integer(C_SIZE_T) :: fresult end function -function swigc_TpetraImport_isLocallyComplete(farg1) & -bind(C, name="_wrap_TpetraImport_isLocallyComplete") & +function swigc_TpetraExport_getNumExportIDs(farg1) & +bind(C, name="_wrap_TpetraExport_getNumExportIDs") & result(fresult) use, intrinsic :: ISO_C_BINDING import :: swigclasswrapper type(SwigClassWrapper) :: farg1 -integer(C_INT) :: fresult +integer(C_SIZE_T) :: fresult end function -function swigc_TpetraImport_setUnion__SWIG_0(farg1, farg2) & -bind(C, name="_wrap_TpetraImport_setUnion__SWIG_0") & +function swigc_TpetraExport_getSourceMap(farg1) & +bind(C, name="_wrap_TpetraExport_getSourceMap") & result(fresult) use, intrinsic :: ISO_C_BINDING import :: swigclasswrapper type(SwigClassWrapper) :: farg1 -type(SwigClassWrapper) :: farg2 type(SwigClassWrapper) :: fresult end function -function swigc_TpetraImport_setUnion__SWIG_1(farg1) & -bind(C, name="_wrap_TpetraImport_setUnion__SWIG_1") & +function swigc_TpetraExport_getTargetMap(farg1) & +bind(C, name="_wrap_TpetraExport_getTargetMap") & result(fresult) use, intrinsic :: ISO_C_BINDING import :: swigclasswrapper @@ -1345,18 +1336,17 @@ function swigc_TpetraImport_setUnion__SWIG_1(farg1) & type(SwigClassWrapper) :: fresult end function -function swigc_TpetraImport_createRemoteOnlyImport(farg1, farg2) & -bind(C, name="_wrap_TpetraImport_createRemoteOnlyImport") & +function swigc_TpetraExport_isLocallyComplete(farg1) & +bind(C, name="_wrap_TpetraExport_isLocallyComplete") & result(fresult) use, intrinsic :: ISO_C_BINDING import :: swigclasswrapper type(SwigClassWrapper) :: farg1 -type(SwigClassWrapper) :: farg2 -type(SwigClassWrapper) :: fresult +integer(C_INT) :: fresult end function - subroutine swigc_assignment_TpetraImport(self, other) & - bind(C, name="_wrap_assign_TpetraImport") + subroutine swigc_assignment_TpetraExport(self, other) & + bind(C, name="_wrap_assign_TpetraExport") use, intrinsic :: ISO_C_BINDING import :: SwigClassWrapper type(SwigClassWrapper), intent(inout) :: self @@ -3021,17 +3011,6 @@ function swigc_new_TpetraCrsGraph__SWIG_13(farg1, farg2, farg3, farg4) & type(SwigClassWrapper) :: fresult end function -subroutine swigc_TpetraCrsGraph_setAllIndices(farg1, farg2, farg3, farg4) & -bind(C, name="_wrap_TpetraCrsGraph_setAllIndices") -use, intrinsic :: ISO_C_BINDING -import :: swigclasswrapper -import :: swigarraywrapper -type(SwigClassWrapper) :: farg1 -type(SwigArrayWrapper) :: farg2 -type(SwigArrayWrapper) :: farg3 -type(SwigArrayWrapper) :: farg4 -end subroutine - subroutine swigc_TpetraCrsGraph_getNodeRowPtrs(farg1, farg2) & bind(C, name="_wrap_TpetraCrsGraph_getNodeRowPtrs") use, intrinsic :: ISO_C_BINDING @@ -4094,46 +4073,6 @@ subroutine swigc_TpetraCrsMatrix_getAllValues(farg1, farg2, farg3, farg4) & type(SwigArrayWrapper) :: farg2 type(SwigArrayWrapper) :: farg3 type(SwigArrayWrapper) :: farg4 -end subroutine - -subroutine swigc_TpetraCrsMatrix_doImport__SWIG_0(farg1, farg2, farg3, farg4) & -bind(C, name="_wrap_TpetraCrsMatrix_doImport__SWIG_0") -use, intrinsic :: ISO_C_BINDING -import :: swigclasswrapper -type(SwigClassWrapper) :: farg1 -type(SwigClassWrapper) :: farg2 -type(SwigClassWrapper) :: farg3 -integer(C_INT), intent(in) :: farg4 -end subroutine - -subroutine swigc_TpetraCrsMatrix_doImport__SWIG_1(farg1, farg2, farg3, farg4) & -bind(C, name="_wrap_TpetraCrsMatrix_doImport__SWIG_1") -use, intrinsic :: ISO_C_BINDING -import :: swigclasswrapper -type(SwigClassWrapper) :: farg1 -type(SwigClassWrapper) :: farg2 -type(SwigClassWrapper) :: farg3 -integer(C_INT), intent(in) :: farg4 -end subroutine - -subroutine swigc_TpetraCrsMatrix_doExport__SWIG_0(farg1, farg2, farg3, farg4) & -bind(C, name="_wrap_TpetraCrsMatrix_doExport__SWIG_0") -use, intrinsic :: ISO_C_BINDING -import :: swigclasswrapper -type(SwigClassWrapper) :: farg1 -type(SwigClassWrapper) :: farg2 -type(SwigClassWrapper) :: farg3 -integer(C_INT), intent(in) :: farg4 -end subroutine - -subroutine swigc_TpetraCrsMatrix_doExport__SWIG_1(farg1, farg2, farg3, farg4) & -bind(C, name="_wrap_TpetraCrsMatrix_doExport__SWIG_1") -use, intrinsic :: ISO_C_BINDING -import :: swigclasswrapper -type(SwigClassWrapper) :: farg1 -type(SwigClassWrapper) :: farg2 -type(SwigClassWrapper) :: farg3 -integer(C_INT), intent(in) :: farg4 end subroutine subroutine swigc_assignment_TpetraCrsMatrix(self, other) & @@ -5491,10 +5430,10 @@ subroutine swigf_assignment_TpetraMap(self, other) type(TpetraMap), intent(in) :: other call swigc_assignment_TpetraMap(self%swigdata, other%swigdata) end subroutine -function new_TpetraExport__SWIG_0(source, target) & +function new_TpetraImport__SWIG_0(source, target) & result(self) use, intrinsic :: ISO_C_BINDING -type(TpetraExport) :: self +type(TpetraImport) :: self class(TpetraMap), intent(in) :: source class(TpetraMap), intent(in) :: target @@ -5505,14 +5444,14 @@ function new_TpetraExport__SWIG_0(source, target) & farg1 = source%swigdata farg2 = target%swigdata -fresult = swigc_new_TpetraExport__SWIG_0(farg1, farg2) +fresult = swigc_new_TpetraImport__SWIG_0(farg1, farg2) self%swigdata = fresult end function -function new_TpetraExport__SWIG_1(source, target, plist) & +function new_TpetraImport__SWIG_1(source, target, plist) & result(self) use, intrinsic :: ISO_C_BINDING -type(TpetraExport) :: self +type(TpetraImport) :: self class(TpetraMap), intent(in) :: source class(TpetraMap), intent(in) :: target @@ -5527,55 +5466,55 @@ function new_TpetraExport__SWIG_1(source, target, plist) & farg1 = source%swigdata farg2 = target%swigdata farg3 = plist%swigdata -fresult = swigc_new_TpetraExport__SWIG_1(farg1, farg2, farg3) +fresult = swigc_new_TpetraImport__SWIG_1(farg1, farg2, farg3) self%swigdata = fresult end function -function new_TpetraExport__SWIG_2(rhs) & +function new_TpetraImport__SWIG_2(importer) & result(self) use, intrinsic :: ISO_C_BINDING -type(TpetraExport) :: self -class(TpetraExport), intent(in) :: rhs +type(TpetraImport) :: self +class(TpetraImport), intent(in) :: importer type(SwigClassWrapper) :: fresult type(SwigClassWrapper) :: farg1 -farg1 = rhs%swigdata -fresult = swigc_new_TpetraExport__SWIG_2(farg1) +farg1 = importer%swigdata +fresult = swigc_new_TpetraImport__SWIG_2(farg1) self%swigdata = fresult end function -function new_TpetraExport__SWIG_3(importer) & +function new_TpetraImport__SWIG_3(exporter) & result(self) use, intrinsic :: ISO_C_BINDING -type(TpetraExport) :: self -class(SWIGTYPE_ImportT_int_long_long_Kokkos__Compat__KokkosSeri1YW4XR), intent(in) :: importer +type(TpetraImport) :: self +class(TpetraExport), intent(in) :: exporter type(SwigClassWrapper) :: fresult type(SwigClassWrapper) :: farg1 -farg1 = importer%swigdata -fresult = swigc_new_TpetraExport__SWIG_3(farg1) +farg1 = exporter%swigdata +fresult = swigc_new_TpetraImport__SWIG_3(farg1) self%swigdata = fresult end function -subroutine delete_TpetraExport(self) +subroutine delete_TpetraImport(self) use, intrinsic :: ISO_C_BINDING -class(TpetraExport), intent(inout) :: self +class(TpetraImport), intent(inout) :: self type(SwigClassWrapper) :: farg1 farg1 = self%swigdata if (self%swigdata%mem == SWIG_OWN) then -call swigc_delete_TpetraExport(farg1) +call swigc_delete_TpetraImport(farg1) end if self%swigdata%cptr = C_NULL_PTR self%swigdata%mem = SWIG_NULL end subroutine -subroutine swigf_TpetraExport_setParameterList(self, plist) +subroutine swigf_TpetraImport_setParameterList(self, plist) use, intrinsic :: ISO_C_BINDING -class(TpetraExport), intent(inout) :: self +class(TpetraImport), intent(inout) :: self class(ParameterList), intent(in) :: plist @@ -5584,117 +5523,167 @@ subroutine swigf_TpetraExport_setParameterList(self, plist) farg1 = self%swigdata farg2 = plist%swigdata -call swigc_TpetraExport_setParameterList(farg1, farg2) +call swigc_TpetraImport_setParameterList(farg1, farg2) end subroutine -function swigf_TpetraExport_getNumSameIDs(self) & +function swigf_TpetraImport_getNumSameIDs(self) & result(swig_result) use, intrinsic :: ISO_C_BINDING integer(C_SIZE_T) :: swig_result -class(TpetraExport), intent(in) :: self +class(TpetraImport), intent(in) :: self integer(C_SIZE_T) :: fresult type(SwigClassWrapper) :: farg1 farg1 = self%swigdata -fresult = swigc_TpetraExport_getNumSameIDs(farg1) +fresult = swigc_TpetraImport_getNumSameIDs(farg1) swig_result = fresult end function -function swigf_TpetraExport_getNumPermuteIDs(self) & +function swigf_TpetraImport_getNumPermuteIDs(self) & result(swig_result) use, intrinsic :: ISO_C_BINDING integer(C_SIZE_T) :: swig_result -class(TpetraExport), intent(in) :: self +class(TpetraImport), intent(in) :: self integer(C_SIZE_T) :: fresult type(SwigClassWrapper) :: farg1 farg1 = self%swigdata -fresult = swigc_TpetraExport_getNumPermuteIDs(farg1) +fresult = swigc_TpetraImport_getNumPermuteIDs(farg1) swig_result = fresult end function -function swigf_TpetraExport_getNumRemoteIDs(self) & +function swigf_TpetraImport_getNumRemoteIDs(self) & result(swig_result) use, intrinsic :: ISO_C_BINDING integer(C_SIZE_T) :: swig_result -class(TpetraExport), intent(in) :: self +class(TpetraImport), intent(in) :: self integer(C_SIZE_T) :: fresult type(SwigClassWrapper) :: farg1 farg1 = self%swigdata -fresult = swigc_TpetraExport_getNumRemoteIDs(farg1) +fresult = swigc_TpetraImport_getNumRemoteIDs(farg1) swig_result = fresult end function -function swigf_TpetraExport_getNumExportIDs(self) & +function swigf_TpetraImport_getNumExportIDs(self) & result(swig_result) use, intrinsic :: ISO_C_BINDING integer(C_SIZE_T) :: swig_result -class(TpetraExport), intent(in) :: self +class(TpetraImport), intent(in) :: self integer(C_SIZE_T) :: fresult type(SwigClassWrapper) :: farg1 farg1 = self%swigdata -fresult = swigc_TpetraExport_getNumExportIDs(farg1) +fresult = swigc_TpetraImport_getNumExportIDs(farg1) swig_result = fresult end function -function swigf_TpetraExport_getSourceMap(self) & +function swigf_TpetraImport_getSourceMap(self) & result(swig_result) use, intrinsic :: ISO_C_BINDING type(TpetraMap) :: swig_result -class(TpetraExport), intent(in) :: self +class(TpetraImport), intent(in) :: self type(SwigClassWrapper) :: fresult type(SwigClassWrapper) :: farg1 farg1 = self%swigdata -fresult = swigc_TpetraExport_getSourceMap(farg1) +fresult = swigc_TpetraImport_getSourceMap(farg1) swig_result%swigdata = fresult end function -function swigf_TpetraExport_getTargetMap(self) & +function swigf_TpetraImport_getTargetMap(self) & result(swig_result) use, intrinsic :: ISO_C_BINDING type(TpetraMap) :: swig_result -class(TpetraExport), intent(in) :: self +class(TpetraImport), intent(in) :: self type(SwigClassWrapper) :: fresult type(SwigClassWrapper) :: farg1 farg1 = self%swigdata -fresult = swigc_TpetraExport_getTargetMap(farg1) +fresult = swigc_TpetraImport_getTargetMap(farg1) swig_result%swigdata = fresult end function -function swigf_TpetraExport_isLocallyComplete(self) & +function swigf_TpetraImport_isLocallyComplete(self) & result(swig_result) use, intrinsic :: ISO_C_BINDING logical :: swig_result -class(TpetraExport), intent(in) :: self +class(TpetraImport), intent(in) :: self integer(C_INT) :: fresult type(SwigClassWrapper) :: farg1 farg1 = self%swigdata -fresult = swigc_TpetraExport_isLocallyComplete(farg1) +fresult = swigc_TpetraImport_isLocallyComplete(farg1) swig_result = SWIG_int_to_logical(fresult) end function - subroutine swigf_assignment_TpetraExport(self, other) +function swigf_TpetraImport_setUnion__SWIG_0(self, rhs) & +result(swig_result) +use, intrinsic :: ISO_C_BINDING +type(TpetraImport) :: swig_result +class(TpetraImport), intent(in) :: self + +class(TpetraImport), intent(in) :: rhs + +type(SwigClassWrapper) :: fresult +type(SwigClassWrapper) :: farg1 +type(SwigClassWrapper) :: farg2 + +farg1 = self%swigdata +farg2 = rhs%swigdata +fresult = swigc_TpetraImport_setUnion__SWIG_0(farg1, farg2) +swig_result%swigdata = fresult +end function + +function swigf_TpetraImport_setUnion__SWIG_1(self) & +result(swig_result) +use, intrinsic :: ISO_C_BINDING +type(TpetraImport) :: swig_result +class(TpetraImport), intent(in) :: self + +type(SwigClassWrapper) :: fresult +type(SwigClassWrapper) :: farg1 + +farg1 = self%swigdata +fresult = swigc_TpetraImport_setUnion__SWIG_1(farg1) +swig_result%swigdata = fresult +end function + +function swigf_TpetraImport_createRemoteOnlyImport(self, remotetarget) & +result(swig_result) +use, intrinsic :: ISO_C_BINDING +type(TpetraImport) :: swig_result +class(TpetraImport), intent(in) :: self + +class(TpetraMap), intent(in) :: remotetarget + +type(SwigClassWrapper) :: fresult +type(SwigClassWrapper) :: farg1 +type(SwigClassWrapper) :: farg2 + +farg1 = self%swigdata +farg2 = remotetarget%swigdata +fresult = swigc_TpetraImport_createRemoteOnlyImport(farg1, farg2) +swig_result%swigdata = fresult +end function + + subroutine swigf_assignment_TpetraImport(self, other) use, intrinsic :: ISO_C_BINDING - class(TpetraExport), intent(inout) :: self - type(TpetraExport), intent(in) :: other - call swigc_assignment_TpetraExport(self%swigdata, other%swigdata) + class(TpetraImport), intent(inout) :: self + type(TpetraImport), intent(in) :: other + call swigc_assignment_TpetraImport(self%swigdata, other%swigdata) end subroutine -function new_TpetraImport__SWIG_0(source, target) & +function new_TpetraExport__SWIG_0(source, target) & result(self) use, intrinsic :: ISO_C_BINDING -type(TpetraImport) :: self +type(TpetraExport) :: self class(TpetraMap), intent(in) :: source class(TpetraMap), intent(in) :: target @@ -5705,14 +5694,14 @@ function new_TpetraImport__SWIG_0(source, target) & farg1 = source%swigdata farg2 = target%swigdata -fresult = swigc_new_TpetraImport__SWIG_0(farg1, farg2) +fresult = swigc_new_TpetraExport__SWIG_0(farg1, farg2) self%swigdata = fresult end function -function new_TpetraImport__SWIG_1(source, target, plist) & +function new_TpetraExport__SWIG_1(source, target, plist) & result(self) use, intrinsic :: ISO_C_BINDING -type(TpetraImport) :: self +type(TpetraExport) :: self class(TpetraMap), intent(in) :: source class(TpetraMap), intent(in) :: target @@ -5727,55 +5716,55 @@ function new_TpetraImport__SWIG_1(source, target, plist) & farg1 = source%swigdata farg2 = target%swigdata farg3 = plist%swigdata -fresult = swigc_new_TpetraImport__SWIG_1(farg1, farg2, farg3) +fresult = swigc_new_TpetraExport__SWIG_1(farg1, farg2, farg3) self%swigdata = fresult end function -function new_TpetraImport__SWIG_2(importer) & +function new_TpetraExport__SWIG_2(rhs) & result(self) use, intrinsic :: ISO_C_BINDING -type(TpetraImport) :: self -class(TpetraImport), intent(in) :: importer +type(TpetraExport) :: self +class(TpetraExport), intent(in) :: rhs type(SwigClassWrapper) :: fresult type(SwigClassWrapper) :: farg1 -farg1 = importer%swigdata -fresult = swigc_new_TpetraImport__SWIG_2(farg1) +farg1 = rhs%swigdata +fresult = swigc_new_TpetraExport__SWIG_2(farg1) self%swigdata = fresult end function -function new_TpetraImport__SWIG_3(exporter) & +function new_TpetraExport__SWIG_3(importer) & result(self) use, intrinsic :: ISO_C_BINDING -type(TpetraImport) :: self -class(TpetraExport), intent(in) :: exporter +type(TpetraExport) :: self +class(TpetraImport), intent(in) :: importer type(SwigClassWrapper) :: fresult type(SwigClassWrapper) :: farg1 -farg1 = exporter%swigdata -fresult = swigc_new_TpetraImport__SWIG_3(farg1) +farg1 = importer%swigdata +fresult = swigc_new_TpetraExport__SWIG_3(farg1) self%swigdata = fresult end function -subroutine delete_TpetraImport(self) +subroutine delete_TpetraExport(self) use, intrinsic :: ISO_C_BINDING -class(TpetraImport), intent(inout) :: self +class(TpetraExport), intent(inout) :: self type(SwigClassWrapper) :: farg1 farg1 = self%swigdata if (self%swigdata%mem == SWIG_OWN) then -call swigc_delete_TpetraImport(farg1) +call swigc_delete_TpetraExport(farg1) end if self%swigdata%cptr = C_NULL_PTR self%swigdata%mem = SWIG_NULL end subroutine -subroutine swigf_TpetraImport_setParameterList(self, plist) +subroutine swigf_TpetraExport_setParameterList(self, plist) use, intrinsic :: ISO_C_BINDING -class(TpetraImport), intent(inout) :: self +class(TpetraExport), intent(inout) :: self class(ParameterList), intent(in) :: plist @@ -5784,162 +5773,112 @@ subroutine swigf_TpetraImport_setParameterList(self, plist) farg1 = self%swigdata farg2 = plist%swigdata -call swigc_TpetraImport_setParameterList(farg1, farg2) +call swigc_TpetraExport_setParameterList(farg1, farg2) end subroutine -function swigf_TpetraImport_getNumSameIDs(self) & +function swigf_TpetraExport_getNumSameIDs(self) & result(swig_result) use, intrinsic :: ISO_C_BINDING integer(C_SIZE_T) :: swig_result -class(TpetraImport), intent(in) :: self +class(TpetraExport), intent(in) :: self integer(C_SIZE_T) :: fresult type(SwigClassWrapper) :: farg1 farg1 = self%swigdata -fresult = swigc_TpetraImport_getNumSameIDs(farg1) +fresult = swigc_TpetraExport_getNumSameIDs(farg1) swig_result = fresult end function -function swigf_TpetraImport_getNumPermuteIDs(self) & +function swigf_TpetraExport_getNumPermuteIDs(self) & result(swig_result) use, intrinsic :: ISO_C_BINDING integer(C_SIZE_T) :: swig_result -class(TpetraImport), intent(in) :: self +class(TpetraExport), intent(in) :: self integer(C_SIZE_T) :: fresult type(SwigClassWrapper) :: farg1 farg1 = self%swigdata -fresult = swigc_TpetraImport_getNumPermuteIDs(farg1) +fresult = swigc_TpetraExport_getNumPermuteIDs(farg1) swig_result = fresult end function -function swigf_TpetraImport_getNumRemoteIDs(self) & +function swigf_TpetraExport_getNumRemoteIDs(self) & result(swig_result) use, intrinsic :: ISO_C_BINDING integer(C_SIZE_T) :: swig_result -class(TpetraImport), intent(in) :: self +class(TpetraExport), intent(in) :: self integer(C_SIZE_T) :: fresult type(SwigClassWrapper) :: farg1 farg1 = self%swigdata -fresult = swigc_TpetraImport_getNumRemoteIDs(farg1) +fresult = swigc_TpetraExport_getNumRemoteIDs(farg1) swig_result = fresult end function -function swigf_TpetraImport_getNumExportIDs(self) & +function swigf_TpetraExport_getNumExportIDs(self) & result(swig_result) use, intrinsic :: ISO_C_BINDING integer(C_SIZE_T) :: swig_result -class(TpetraImport), intent(in) :: self +class(TpetraExport), intent(in) :: self integer(C_SIZE_T) :: fresult type(SwigClassWrapper) :: farg1 farg1 = self%swigdata -fresult = swigc_TpetraImport_getNumExportIDs(farg1) +fresult = swigc_TpetraExport_getNumExportIDs(farg1) swig_result = fresult end function -function swigf_TpetraImport_getSourceMap(self) & +function swigf_TpetraExport_getSourceMap(self) & result(swig_result) use, intrinsic :: ISO_C_BINDING type(TpetraMap) :: swig_result -class(TpetraImport), intent(in) :: self +class(TpetraExport), intent(in) :: self type(SwigClassWrapper) :: fresult type(SwigClassWrapper) :: farg1 farg1 = self%swigdata -fresult = swigc_TpetraImport_getSourceMap(farg1) +fresult = swigc_TpetraExport_getSourceMap(farg1) swig_result%swigdata = fresult end function -function swigf_TpetraImport_getTargetMap(self) & +function swigf_TpetraExport_getTargetMap(self) & result(swig_result) use, intrinsic :: ISO_C_BINDING type(TpetraMap) :: swig_result -class(TpetraImport), intent(in) :: self +class(TpetraExport), intent(in) :: self type(SwigClassWrapper) :: fresult type(SwigClassWrapper) :: farg1 farg1 = self%swigdata -fresult = swigc_TpetraImport_getTargetMap(farg1) +fresult = swigc_TpetraExport_getTargetMap(farg1) swig_result%swigdata = fresult end function -function swigf_TpetraImport_isLocallyComplete(self) & +function swigf_TpetraExport_isLocallyComplete(self) & result(swig_result) use, intrinsic :: ISO_C_BINDING logical :: swig_result -class(TpetraImport), intent(in) :: self +class(TpetraExport), intent(in) :: self integer(C_INT) :: fresult type(SwigClassWrapper) :: farg1 farg1 = self%swigdata -fresult = swigc_TpetraImport_isLocallyComplete(farg1) +fresult = swigc_TpetraExport_isLocallyComplete(farg1) swig_result = SWIG_int_to_logical(fresult) end function -function swigf_TpetraImport_setUnion__SWIG_0(self, rhs) & -result(swig_result) -use, intrinsic :: ISO_C_BINDING -type(TpetraImport) :: swig_result -class(TpetraImport), intent(in) :: self - -class(TpetraImport), intent(in) :: rhs - -type(SwigClassWrapper) :: fresult -type(SwigClassWrapper) :: farg1 -type(SwigClassWrapper) :: farg2 - -farg1 = self%swigdata -farg2 = rhs%swigdata -fresult = swigc_TpetraImport_setUnion__SWIG_0(farg1, farg2) -swig_result%swigdata = fresult -end function - -function swigf_TpetraImport_setUnion__SWIG_1(self) & -result(swig_result) -use, intrinsic :: ISO_C_BINDING -type(TpetraImport) :: swig_result -class(TpetraImport), intent(in) :: self - -type(SwigClassWrapper) :: fresult -type(SwigClassWrapper) :: farg1 - -farg1 = self%swigdata -fresult = swigc_TpetraImport_setUnion__SWIG_1(farg1) -swig_result%swigdata = fresult -end function - -function swigf_TpetraImport_createRemoteOnlyImport(self, remotetarget) & -result(swig_result) -use, intrinsic :: ISO_C_BINDING -type(TpetraImport) :: swig_result -class(TpetraImport), intent(in) :: self - -class(TpetraMap), intent(in) :: remotetarget - -type(SwigClassWrapper) :: fresult -type(SwigClassWrapper) :: farg1 -type(SwigClassWrapper) :: farg2 - -farg1 = self%swigdata -farg2 = remotetarget%swigdata -fresult = swigc_TpetraImport_createRemoteOnlyImport(farg1, farg2) -swig_result%swigdata = fresult -end function - - subroutine swigf_assignment_TpetraImport(self, other) + subroutine swigf_assignment_TpetraExport(self, other) use, intrinsic :: ISO_C_BINDING - class(TpetraImport), intent(inout) :: self - type(TpetraImport), intent(in) :: other - call swigc_assignment_TpetraImport(self%swigdata, other%swigdata) + class(TpetraExport), intent(inout) :: self + type(TpetraExport), intent(in) :: other + call swigc_assignment_TpetraExport(self%swigdata, other%swigdata) end subroutine function new_TpetraMultiVector__SWIG_0() & result(self) @@ -9109,35 +9048,6 @@ function new_TpetraCrsGraph__SWIG_13(rowmap, colmap, rowpointers, columnindices) self%swigdata = fresult end function -subroutine swigf_TpetraCrsGraph_setAllIndices(self, rowpointers, columnindices, val) -use, intrinsic :: ISO_C_BINDING -class(TpetraCrsGraph), intent(inout) :: self - -integer(C_LONG), dimension(:), target :: rowpointers -integer(C_LONG), pointer :: farg2_view -integer(C_INT), dimension(:), target :: columnindices -integer(C_INT), pointer :: farg3_view -real(C_DOUBLE), dimension(:), target :: val -real(C_DOUBLE), pointer :: farg4_view - -type(SwigClassWrapper) :: farg1 -type(SwigArrayWrapper) :: farg2 -type(SwigArrayWrapper) :: farg3 -type(SwigArrayWrapper) :: farg4 - -farg1 = self%swigdata -farg2_view => rowpointers(1) -farg2%data = c_loc(farg2_view) -farg2%size = size(rowpointers) -farg3_view => columnindices(1) -farg3%data = c_loc(farg3_view) -farg3%size = size(columnindices) -farg4_view => val(1) -farg4%data = c_loc(farg4_view) -farg4%size = size(val) -call swigc_TpetraCrsGraph_setAllIndices(farg1, farg2, farg3, farg4) -end subroutine - subroutine swigf_TpetraCrsGraph_getNodeRowPtrs(self, rowpointers) use, intrinsic :: ISO_C_BINDING class(TpetraCrsGraph), intent(in) :: self @@ -11254,94 +11164,6 @@ subroutine swigf_TpetraCrsMatrix_getAllValues(self, rowpointers, columnindices, farg4%data = c_loc(farg4_view) farg4%size = size(values) call swigc_TpetraCrsMatrix_getAllValues(farg1, farg2, farg3, farg4) -end subroutine - -subroutine swigf_TpetraCrsMatrix_doImport__SWIG_0(self, source, importer, cm) -use, intrinsic :: ISO_C_BINDING -class(TpetraCrsMatrix), intent(inout) :: self - -class(TpetraCrsMatrix), intent(in) :: source - -class(TpetraImport), intent(in) :: importer - -integer(TpetraCombineMode), intent(in) :: cm - -type(SwigClassWrapper) :: farg1 -type(SwigClassWrapper) :: farg2 -type(SwigClassWrapper) :: farg3 -integer(C_INT) :: farg4 - -farg1 = self%swigdata -farg2 = source%swigdata -farg3 = importer%swigdata -farg4 = cm -call swigc_TpetraCrsMatrix_doImport__SWIG_0(farg1, farg2, farg3, farg4) -end subroutine - -subroutine swigf_TpetraCrsMatrix_doImport__SWIG_1(self, source, exporter, cm) -use, intrinsic :: ISO_C_BINDING -class(TpetraCrsMatrix), intent(inout) :: self - -class(TpetraCrsMatrix), intent(in) :: source - -class(TpetraExport), intent(in) :: exporter - -integer(TpetraCombineMode), intent(in) :: cm - -type(SwigClassWrapper) :: farg1 -type(SwigClassWrapper) :: farg2 -type(SwigClassWrapper) :: farg3 -integer(C_INT) :: farg4 - -farg1 = self%swigdata -farg2 = source%swigdata -farg3 = exporter%swigdata -farg4 = cm -call swigc_TpetraCrsMatrix_doImport__SWIG_1(farg1, farg2, farg3, farg4) -end subroutine - -subroutine swigf_TpetraCrsMatrix_doExport__SWIG_0(self, source, exporter, cm) -use, intrinsic :: ISO_C_BINDING -class(TpetraCrsMatrix), intent(inout) :: self - -class(TpetraCrsMatrix), intent(in) :: source - -class(TpetraExport), intent(in) :: exporter - -integer(TpetraCombineMode), intent(in) :: cm - -type(SwigClassWrapper) :: farg1 -type(SwigClassWrapper) :: farg2 -type(SwigClassWrapper) :: farg3 -integer(C_INT) :: farg4 - -farg1 = self%swigdata -farg2 = source%swigdata -farg3 = exporter%swigdata -farg4 = cm -call swigc_TpetraCrsMatrix_doExport__SWIG_0(farg1, farg2, farg3, farg4) -end subroutine - -subroutine swigf_TpetraCrsMatrix_doExport__SWIG_1(self, source, importer, cm) -use, intrinsic :: ISO_C_BINDING -class(TpetraCrsMatrix), intent(inout) :: self - -class(TpetraCrsMatrix), intent(in) :: source - -class(TpetraImport), intent(in) :: importer - -integer(TpetraCombineMode), intent(in) :: cm - -type(SwigClassWrapper) :: farg1 -type(SwigClassWrapper) :: farg2 -type(SwigClassWrapper) :: farg3 -integer(C_INT) :: farg4 - -farg1 = self%swigdata -farg2 = source%swigdata -farg3 = importer%swigdata -farg4 = cm -call swigc_TpetraCrsMatrix_doExport__SWIG_1(farg1, farg2, farg3, farg4) end subroutine subroutine swigf_assignment_TpetraCrsMatrix(self, other) diff --git a/src/tpetra/src/swig/fortpetraFORTRAN_wrap.cxx b/src/tpetra/src/swig/fortpetraFORTRAN_wrap.cxx index 56b8204d..12200542 100644 --- a/src/tpetra/src/swig/fortpetraFORTRAN_wrap.cxx +++ b/src/tpetra/src/swig/fortpetraFORTRAN_wrap.cxx @@ -584,12 +584,8 @@ SWIGINTERN void SWIG_assign_impl(SwigClassWrapper* self, SwigClassWrapper* other } -#include "Tpetra_Export.hpp" -// !FIXME -using Tpetra::Import; - - #include "Tpetra_Import.hpp" +#include "Tpetra_Export.hpp" #include "Tpetra_MultiVector.hpp" @@ -725,15 +721,6 @@ SWIGINTERN Tpetra::CrsGraph< LO,GO,NO > *new_Tpetra_CrsGraph_Sl_LO_Sc_GO_Sc_NO_S return new Tpetra::CrsGraph(rowMap, colMap, Teuchos::arcpFromArray(rowPointersArray), Teuchos::arcpFromArray(columnIndicesArray), params); } -SWIGINTERN void Tpetra_CrsGraph_Sl_LO_Sc_GO_Sc_NO_Sg__setAllIndices(Tpetra::CrsGraph< LO,GO,NO > *self,Teuchos::ArrayView< std::size_t > rowPointers,Teuchos::ArrayView< LO > columnIndices,Teuchos::ArrayView< SC > val){ - Teuchos::ArrayRCP rowPointersArrayRCP(rowPointers.size()); - for (int i = 0; i < rowPointersArrayRCP.size(); i++) - rowPointersArrayRCP[i] = rowPointers[i]-1; - Teuchos::ArrayRCP columnIndicesArrayRCP(columnIndices.size()); - for (int i = 0; i < columnIndicesArrayRCP.size(); i++) - columnIndicesArrayRCP[i] = columnIndices[i]-1; - self->setAllIndices(rowPointersArrayRCP, columnIndicesArrayRCP); - } SWIGINTERN void Tpetra_CrsGraph_Sl_LO_Sc_GO_Sc_NO_Sg__getNodeRowPtrs(Tpetra::CrsGraph< LO,GO,NO > const *self,Teuchos::ArrayView< std::size_t > rowPointers){ auto rowPointersArrayRCP = self->getNodeRowPtrs(); TEUCHOS_TEST_FOR_EXCEPTION(rowPointersArrayRCP.size() != rowPointers.size(), std::runtime_error, "Wrong rowPointers size"); @@ -805,18 +792,6 @@ SWIGINTERN void Tpetra_CrsMatrix_Sl_SC_Sc_LO_Sc_GO_Sc_NO_Sg__getAllValues(Tpetra values [i] = valuesArrayRCP[i]; } } -SWIGINTERN void Tpetra_CrsMatrix_Sl_SC_Sc_LO_Sc_GO_Sc_NO_Sg__doImport__SWIG_0(Tpetra::CrsMatrix< SC,LO,GO,NO > *self,Tpetra::CrsMatrix< SC,LO,GO,NO > const &source,Tpetra::Import< LO,GO,NO > const &importer,Tpetra::CombineMode CM){ - self->doImport(source, importer, CM); - } -SWIGINTERN void Tpetra_CrsMatrix_Sl_SC_Sc_LO_Sc_GO_Sc_NO_Sg__doImport__SWIG_1(Tpetra::CrsMatrix< SC,LO,GO,NO > *self,Tpetra::CrsMatrix< SC,LO,GO,NO > const &source,Tpetra::Export< LO,GO,NO > const &exporter,Tpetra::CombineMode CM){ - self->doImport(source, exporter, CM); - } -SWIGINTERN void Tpetra_CrsMatrix_Sl_SC_Sc_LO_Sc_GO_Sc_NO_Sg__doExport__SWIG_0(Tpetra::CrsMatrix< SC,LO,GO,NO > *self,Tpetra::CrsMatrix< SC,LO,GO,NO > const &source,Tpetra::Export< LO,GO,NO > const &exporter,Tpetra::CombineMode CM){ - self->doExport(source, exporter, CM); - } -SWIGINTERN void Tpetra_CrsMatrix_Sl_SC_Sc_LO_Sc_GO_Sc_NO_Sg__doExport__SWIG_1(Tpetra::CrsMatrix< SC,LO,GO,NO > *self,Tpetra::CrsMatrix< SC,LO,GO,NO > const &source,Tpetra::Import< LO,GO,NO > const &importer,Tpetra::CombineMode CM){ - self->doExport(source, importer, CM); - } #include "Tpetra_CrsMatrix.hpp" @@ -2403,170 +2378,172 @@ SWIGEXPORT void _wrap_assign_TpetraMap(SwigClassWrapper * self, SwigClassWrapper } -SWIGEXPORT SwigClassWrapper _wrap_new_TpetraExport__SWIG_0(SwigClassWrapper const *farg1, SwigClassWrapper const *farg2) { +SWIGEXPORT SwigClassWrapper _wrap_new_TpetraImport__SWIG_0(SwigClassWrapper const *farg1, SwigClassWrapper const *farg2) { SwigClassWrapper fresult ; - Teuchos::RCP< Tpetra::Export< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > *arg1 = 0 ; - Teuchos::RCP< Tpetra::Export< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > *arg2 = 0 ; - Teuchos::RCP< Tpetra::Export< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > tempnull1 ; - Teuchos::RCP< Tpetra::Export< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > tempnull2 ; - Tpetra::Export< LO,GO,NO > *result = 0 ; + Teuchos::RCP< Tpetra::Import< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > *arg1 = 0 ; + Teuchos::RCP< Tpetra::Import< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > *arg2 = 0 ; + Teuchos::RCP< Tpetra::Import< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > tempnull1 ; + Teuchos::RCP< Tpetra::Import< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > tempnull2 ; + Tpetra::Import< LO,GO,NO > *result = 0 ; - arg1 = farg1->cptr ? static_cast< Teuchos::RCP< Tpetra::Export< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg1->cptr) : &tempnull1; - arg2 = farg2->cptr ? static_cast< Teuchos::RCP< Tpetra::Export< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg2->cptr) : &tempnull2; + arg1 = farg1->cptr ? static_cast< Teuchos::RCP< Tpetra::Import< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg1->cptr) : &tempnull1; + arg2 = farg2->cptr ? static_cast< Teuchos::RCP< Tpetra::Import< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg2->cptr) : &tempnull2; { // Make sure no unhandled exceptions exist before performing a new action - SWIG_check_unhandled_exception_impl("Tpetra::Export< LO,GO,NO >::Export(Teuchos::RCP< Tpetra::Export< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::Export< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &)");; + SWIG_check_unhandled_exception_impl("Tpetra::Import< LO,GO,NO >::Import(Teuchos::RCP< Tpetra::Import< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::Import< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &)");; try { // Attempt the wrapped function call - result = (Tpetra::Export< LO,GO,NO > *)new Tpetra::Export< LO,GO,NO >((Teuchos::RCP< Tpetra::Export< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &)*arg1,(Teuchos::RCP< Tpetra::Export< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &)*arg2); + result = (Tpetra::Import< LO,GO,NO > *)new Tpetra::Import< LO,GO,NO >((Teuchos::RCP< Tpetra::Import< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &)*arg1,(Teuchos::RCP< Tpetra::Import< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &)*arg2); } catch (const std::range_error& e) { // Store a C++ exception - SWIG_exception_impl("Tpetra::Export< LO,GO,NO >::Export(Teuchos::RCP< Tpetra::Export< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::Export< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &)", SWIG_IndexError, e.what(), return SwigClassWrapper_uninitialized()); + SWIG_exception_impl("Tpetra::Import< LO,GO,NO >::Import(Teuchos::RCP< Tpetra::Import< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::Import< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &)", SWIG_IndexError, e.what(), return SwigClassWrapper_uninitialized()); } catch (const std::exception& e) { // Store a C++ exception - SWIG_exception_impl("Tpetra::Export< LO,GO,NO >::Export(Teuchos::RCP< Tpetra::Export< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::Export< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &)", SWIG_RuntimeError, e.what(), return SwigClassWrapper_uninitialized()); + SWIG_exception_impl("Tpetra::Import< LO,GO,NO >::Import(Teuchos::RCP< Tpetra::Import< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::Import< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &)", SWIG_RuntimeError, e.what(), return SwigClassWrapper_uninitialized()); } catch (...) { - SWIG_exception_impl("Tpetra::Export< LO,GO,NO >::Export(Teuchos::RCP< Tpetra::Export< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::Export< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &)", SWIG_UnknownError, "An unknown exception occurred", return SwigClassWrapper_uninitialized()); + SWIG_exception_impl("Tpetra::Import< LO,GO,NO >::Import(Teuchos::RCP< Tpetra::Import< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::Import< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &)", SWIG_UnknownError, "An unknown exception occurred", return SwigClassWrapper_uninitialized()); } } - fresult.cptr = result ? new Teuchos::RCP< Tpetra::Export >(result SWIG_NO_NULL_DELETER_1) : NULL; + fresult.cptr = result ? new Teuchos::RCP< Tpetra::Import >(result SWIG_NO_NULL_DELETER_1) : NULL; fresult.mem = SWIG_MOVE; return fresult; } -SWIGEXPORT SwigClassWrapper _wrap_new_TpetraExport__SWIG_1(SwigClassWrapper const *farg1, SwigClassWrapper const *farg2, SwigClassWrapper const *farg3) { +SWIGEXPORT SwigClassWrapper _wrap_new_TpetraImport__SWIG_1(SwigClassWrapper const *farg1, SwigClassWrapper const *farg2, SwigClassWrapper const *farg3) { SwigClassWrapper fresult ; - Teuchos::RCP< Tpetra::Export< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > *arg1 = 0 ; - Teuchos::RCP< Tpetra::Export< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > *arg2 = 0 ; + Teuchos::RCP< Tpetra::Import< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > *arg1 = 0 ; + Teuchos::RCP< Tpetra::Import< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > *arg2 = 0 ; Teuchos::RCP< Teuchos::ParameterList > *arg3 = 0 ; - Teuchos::RCP< Tpetra::Export< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > tempnull1 ; - Teuchos::RCP< Tpetra::Export< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > tempnull2 ; + Teuchos::RCP< Tpetra::Import< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > tempnull1 ; + Teuchos::RCP< Tpetra::Import< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > tempnull2 ; Teuchos::RCP< Teuchos::ParameterList > tempnull3 ; - Tpetra::Export< LO,GO,NO > *result = 0 ; + Tpetra::Import< LO,GO,NO > *result = 0 ; - arg1 = farg1->cptr ? static_cast< Teuchos::RCP< Tpetra::Export< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg1->cptr) : &tempnull1; - arg2 = farg2->cptr ? static_cast< Teuchos::RCP< Tpetra::Export< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg2->cptr) : &tempnull2; + arg1 = farg1->cptr ? static_cast< Teuchos::RCP< Tpetra::Import< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg1->cptr) : &tempnull1; + arg2 = farg2->cptr ? static_cast< Teuchos::RCP< Tpetra::Import< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg2->cptr) : &tempnull2; arg3 = farg3->cptr ? static_cast< Teuchos::RCP< Teuchos::ParameterList > * >(farg3->cptr) : &tempnull3; { // Make sure no unhandled exceptions exist before performing a new action - SWIG_check_unhandled_exception_impl("Tpetra::Export< LO,GO,NO >::Export(Teuchos::RCP< Tpetra::Export< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::Export< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Teuchos::ParameterList > const &)");; + SWIG_check_unhandled_exception_impl("Tpetra::Import< LO,GO,NO >::Import(Teuchos::RCP< Tpetra::Import< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::Import< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Teuchos::ParameterList > const &)");; try { // Attempt the wrapped function call - result = (Tpetra::Export< LO,GO,NO > *)new Tpetra::Export< LO,GO,NO >((Teuchos::RCP< Tpetra::Export< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &)*arg1,(Teuchos::RCP< Tpetra::Export< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &)*arg2,(Teuchos::RCP< Teuchos::ParameterList > const &)*arg3); + result = (Tpetra::Import< LO,GO,NO > *)new Tpetra::Import< LO,GO,NO >((Teuchos::RCP< Tpetra::Import< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &)*arg1,(Teuchos::RCP< Tpetra::Import< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &)*arg2,(Teuchos::RCP< Teuchos::ParameterList > const &)*arg3); } catch (const std::range_error& e) { // Store a C++ exception - SWIG_exception_impl("Tpetra::Export< LO,GO,NO >::Export(Teuchos::RCP< Tpetra::Export< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::Export< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Teuchos::ParameterList > const &)", SWIG_IndexError, e.what(), return SwigClassWrapper_uninitialized()); + SWIG_exception_impl("Tpetra::Import< LO,GO,NO >::Import(Teuchos::RCP< Tpetra::Import< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::Import< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Teuchos::ParameterList > const &)", SWIG_IndexError, e.what(), return SwigClassWrapper_uninitialized()); } catch (const std::exception& e) { // Store a C++ exception - SWIG_exception_impl("Tpetra::Export< LO,GO,NO >::Export(Teuchos::RCP< Tpetra::Export< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::Export< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Teuchos::ParameterList > const &)", SWIG_RuntimeError, e.what(), return SwigClassWrapper_uninitialized()); + SWIG_exception_impl("Tpetra::Import< LO,GO,NO >::Import(Teuchos::RCP< Tpetra::Import< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::Import< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Teuchos::ParameterList > const &)", SWIG_RuntimeError, e.what(), return SwigClassWrapper_uninitialized()); } catch (...) { - SWIG_exception_impl("Tpetra::Export< LO,GO,NO >::Export(Teuchos::RCP< Tpetra::Export< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::Export< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Teuchos::ParameterList > const &)", SWIG_UnknownError, "An unknown exception occurred", return SwigClassWrapper_uninitialized()); + SWIG_exception_impl("Tpetra::Import< LO,GO,NO >::Import(Teuchos::RCP< Tpetra::Import< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::Import< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Teuchos::ParameterList > const &)", SWIG_UnknownError, "An unknown exception occurred", return SwigClassWrapper_uninitialized()); } } - fresult.cptr = result ? new Teuchos::RCP< Tpetra::Export >(result SWIG_NO_NULL_DELETER_1) : NULL; + fresult.cptr = result ? new Teuchos::RCP< Tpetra::Import >(result SWIG_NO_NULL_DELETER_1) : NULL; fresult.mem = SWIG_MOVE; return fresult; } -SWIGEXPORT SwigClassWrapper _wrap_new_TpetraExport__SWIG_2(SwigClassWrapper const *farg1) { +SWIGEXPORT SwigClassWrapper _wrap_new_TpetraImport__SWIG_2(SwigClassWrapper const *farg1) { SwigClassWrapper fresult ; - Tpetra::Export< int,long long,Kokkos::Compat::KokkosSerialWrapperNode > *arg1 = 0 ; - Teuchos::RCP< Tpetra::Export< LO,GO,NO > const > *smartarg1 ; - Tpetra::Export< LO,GO,NO > *result = 0 ; + Tpetra::Import< int,long long,Kokkos::Compat::KokkosSerialWrapperNode > *arg1 = 0 ; + Teuchos::RCP< Tpetra::Import< LO,GO,NO > const > *smartarg1 ; + Tpetra::Import< LO,GO,NO > *result = 0 ; - SWIG_check_sp_nonnull(farg1, "Tpetra::Export< int,long long,Kokkos::Compat::KokkosSerialWrapperNode > *", "TpetraExport", "Tpetra::Export< LO,GO,NO >::Export(Tpetra::Export< int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &)", return SwigClassWrapper_uninitialized()) - smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); - arg1 = const_cast< Tpetra::Export* >(smartarg1->get()); + SWIG_check_sp_nonnull(farg1, "Tpetra::Import< int,long long,Kokkos::Compat::KokkosSerialWrapperNode > *", "TpetraImport", "Tpetra::Import< LO,GO,NO >::Import(Tpetra::Import< int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &)", return SwigClassWrapper_uninitialized()) + smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); + arg1 = const_cast< Tpetra::Import* >(smartarg1->get()); { // Make sure no unhandled exceptions exist before performing a new action - SWIG_check_unhandled_exception_impl("Tpetra::Export< LO,GO,NO >::Export(Tpetra::Export< int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &)");; + SWIG_check_unhandled_exception_impl("Tpetra::Import< LO,GO,NO >::Import(Tpetra::Import< int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &)");; try { // Attempt the wrapped function call - result = (Tpetra::Export< LO,GO,NO > *)new Tpetra::Export< LO,GO,NO >((Tpetra::Export< int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &)*arg1); + result = (Tpetra::Import< LO,GO,NO > *)new Tpetra::Import< LO,GO,NO >((Tpetra::Import< int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &)*arg1); } catch (const std::range_error& e) { // Store a C++ exception - SWIG_exception_impl("Tpetra::Export< LO,GO,NO >::Export(Tpetra::Export< int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &)", SWIG_IndexError, e.what(), return SwigClassWrapper_uninitialized()); + SWIG_exception_impl("Tpetra::Import< LO,GO,NO >::Import(Tpetra::Import< int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &)", SWIG_IndexError, e.what(), return SwigClassWrapper_uninitialized()); } catch (const std::exception& e) { // Store a C++ exception - SWIG_exception_impl("Tpetra::Export< LO,GO,NO >::Export(Tpetra::Export< int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &)", SWIG_RuntimeError, e.what(), return SwigClassWrapper_uninitialized()); + SWIG_exception_impl("Tpetra::Import< LO,GO,NO >::Import(Tpetra::Import< int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &)", SWIG_RuntimeError, e.what(), return SwigClassWrapper_uninitialized()); } catch (...) { - SWIG_exception_impl("Tpetra::Export< LO,GO,NO >::Export(Tpetra::Export< int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &)", SWIG_UnknownError, "An unknown exception occurred", return SwigClassWrapper_uninitialized()); + SWIG_exception_impl("Tpetra::Import< LO,GO,NO >::Import(Tpetra::Import< int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &)", SWIG_UnknownError, "An unknown exception occurred", return SwigClassWrapper_uninitialized()); } } - fresult.cptr = result ? new Teuchos::RCP< Tpetra::Export >(result SWIG_NO_NULL_DELETER_1) : NULL; + fresult.cptr = result ? new Teuchos::RCP< Tpetra::Import >(result SWIG_NO_NULL_DELETER_1) : NULL; fresult.mem = SWIG_MOVE; return fresult; } -SWIGEXPORT SwigClassWrapper _wrap_new_TpetraExport__SWIG_3(SwigClassWrapper const *farg1) { +SWIGEXPORT SwigClassWrapper _wrap_new_TpetraImport__SWIG_3(SwigClassWrapper const *farg1) { SwigClassWrapper fresult ; - Import< int,long long,Kokkos::Compat::KokkosSerialWrapperNode > *arg1 = 0 ; - Tpetra::Export< LO,GO,NO > *result = 0 ; + Tpetra::Export< int,long long,Kokkos::Compat::KokkosSerialWrapperNode > *arg1 = 0 ; + Teuchos::RCP< Tpetra::Export< LO,GO,NO > const > *smartarg1 ; + Tpetra::Import< LO,GO,NO > *result = 0 ; - SWIG_check_nonnull(*farg1, "Import< int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &", "SWIGTYPE_ImportT_int_long_long_Kokkos__Compat__KokkosSeri1YW4XR", "Tpetra::Export< LO,GO,NO >::Export(Import< int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &)", return SwigClassWrapper_uninitialized()); - arg1 = static_cast< Import< int,long long,Kokkos::Compat::KokkosSerialWrapperNode > * >(farg1->cptr); + SWIG_check_sp_nonnull(farg1, "Tpetra::Export< int,long long,Kokkos::Compat::KokkosSerialWrapperNode > *", "TpetraExport", "Tpetra::Import< LO,GO,NO >::Import(Tpetra::Export< int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &)", return SwigClassWrapper_uninitialized()) + smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); + arg1 = const_cast< Tpetra::Export* >(smartarg1->get()); { // Make sure no unhandled exceptions exist before performing a new action - SWIG_check_unhandled_exception_impl("Tpetra::Export< LO,GO,NO >::Export(Import< int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &)");; + SWIG_check_unhandled_exception_impl("Tpetra::Import< LO,GO,NO >::Import(Tpetra::Export< int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &)");; try { // Attempt the wrapped function call - result = (Tpetra::Export< LO,GO,NO > *)new Tpetra::Export< LO,GO,NO >((Import< int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &)*arg1); + result = (Tpetra::Import< LO,GO,NO > *)new Tpetra::Import< LO,GO,NO >((Tpetra::Export< int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &)*arg1); } catch (const std::range_error& e) { // Store a C++ exception - SWIG_exception_impl("Tpetra::Export< LO,GO,NO >::Export(Import< int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &)", SWIG_IndexError, e.what(), return SwigClassWrapper_uninitialized()); + SWIG_exception_impl("Tpetra::Import< LO,GO,NO >::Import(Tpetra::Export< int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &)", SWIG_IndexError, e.what(), return SwigClassWrapper_uninitialized()); } catch (const std::exception& e) { // Store a C++ exception - SWIG_exception_impl("Tpetra::Export< LO,GO,NO >::Export(Import< int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &)", SWIG_RuntimeError, e.what(), return SwigClassWrapper_uninitialized()); + SWIG_exception_impl("Tpetra::Import< LO,GO,NO >::Import(Tpetra::Export< int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &)", SWIG_RuntimeError, e.what(), return SwigClassWrapper_uninitialized()); } catch (...) { - SWIG_exception_impl("Tpetra::Export< LO,GO,NO >::Export(Import< int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &)", SWIG_UnknownError, "An unknown exception occurred", return SwigClassWrapper_uninitialized()); + SWIG_exception_impl("Tpetra::Import< LO,GO,NO >::Import(Tpetra::Export< int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &)", SWIG_UnknownError, "An unknown exception occurred", return SwigClassWrapper_uninitialized()); } } - fresult.cptr = result ? new Teuchos::RCP< Tpetra::Export >(result SWIG_NO_NULL_DELETER_1) : NULL; + fresult.cptr = result ? new Teuchos::RCP< Tpetra::Import >(result SWIG_NO_NULL_DELETER_1) : NULL; fresult.mem = SWIG_MOVE; return fresult; } -SWIGEXPORT void _wrap_delete_TpetraExport(SwigClassWrapper const *farg1) { - Tpetra::Export< LO,GO,NO > *arg1 = (Tpetra::Export< LO,GO,NO > *) 0 ; - Teuchos::RCP< Tpetra::Export< LO,GO,NO > > *smartarg1 ; +SWIGEXPORT void _wrap_delete_TpetraImport(SwigClassWrapper const *farg1) { + Tpetra::Import< LO,GO,NO > *arg1 = (Tpetra::Import< LO,GO,NO > *) 0 ; + Teuchos::RCP< Tpetra::Import< LO,GO,NO > > *smartarg1 ; - smartarg1 = static_cast< Teuchos::RCP< Tpetra::Export >* >(farg1->cptr); - arg1 = smartarg1 ? const_cast< Tpetra::Export* >(smartarg1->get()) : NULL; + smartarg1 = static_cast< Teuchos::RCP< Tpetra::Import >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::Import* >(smartarg1->get()) : NULL; { // Make sure no unhandled exceptions exist before performing a new action - SWIG_check_unhandled_exception_impl("Tpetra::Export< LO,GO,NO >::~Export()");; + SWIG_check_unhandled_exception_impl("Tpetra::Import< LO,GO,NO >::~Import()");; try { // Attempt the wrapped function call @@ -2575,34 +2552,34 @@ SWIGEXPORT void _wrap_delete_TpetraExport(SwigClassWrapper const *farg1) { catch (const std::range_error& e) { // Store a C++ exception - SWIG_exception_impl("Tpetra::Export< LO,GO,NO >::~Export()", SWIG_IndexError, e.what(), return ); + SWIG_exception_impl("Tpetra::Import< LO,GO,NO >::~Import()", SWIG_IndexError, e.what(), return ); } catch (const std::exception& e) { // Store a C++ exception - SWIG_exception_impl("Tpetra::Export< LO,GO,NO >::~Export()", SWIG_RuntimeError, e.what(), return ); + SWIG_exception_impl("Tpetra::Import< LO,GO,NO >::~Import()", SWIG_RuntimeError, e.what(), return ); } catch (...) { - SWIG_exception_impl("Tpetra::Export< LO,GO,NO >::~Export()", SWIG_UnknownError, "An unknown exception occurred", return ); + SWIG_exception_impl("Tpetra::Import< LO,GO,NO >::~Import()", SWIG_UnknownError, "An unknown exception occurred", return ); } } } -SWIGEXPORT void _wrap_TpetraExport_setParameterList(SwigClassWrapper const *farg1, SwigClassWrapper const *farg2) { - Tpetra::Export< LO,GO,NO > *arg1 = (Tpetra::Export< LO,GO,NO > *) 0 ; +SWIGEXPORT void _wrap_TpetraImport_setParameterList(SwigClassWrapper const *farg1, SwigClassWrapper const *farg2) { + Tpetra::Import< LO,GO,NO > *arg1 = (Tpetra::Import< LO,GO,NO > *) 0 ; Teuchos::RCP< Teuchos::ParameterList > *arg2 = 0 ; - Teuchos::RCP< Tpetra::Export< LO,GO,NO > > *smartarg1 ; + Teuchos::RCP< Tpetra::Import< LO,GO,NO > > *smartarg1 ; Teuchos::RCP< Teuchos::ParameterList > tempnull2 ; - smartarg1 = static_cast< Teuchos::RCP< Tpetra::Export >* >(farg1->cptr); - arg1 = smartarg1 ? const_cast< Tpetra::Export* >(smartarg1->get()) : NULL; + smartarg1 = static_cast< Teuchos::RCP< Tpetra::Import >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::Import* >(smartarg1->get()) : NULL; arg2 = farg2->cptr ? static_cast< Teuchos::RCP< Teuchos::ParameterList > * >(farg2->cptr) : &tempnull2; { // Make sure no unhandled exceptions exist before performing a new action - SWIG_check_unhandled_exception_impl("Tpetra::Export< LO,GO,NO >::setParameterList(Teuchos::RCP< Teuchos::ParameterList > const &)");; + SWIG_check_unhandled_exception_impl("Tpetra::Import< LO,GO,NO >::setParameterList(Teuchos::RCP< Teuchos::ParameterList > const &)");; try { // Attempt the wrapped function call @@ -2611,51 +2588,51 @@ SWIGEXPORT void _wrap_TpetraExport_setParameterList(SwigClassWrapper const *farg catch (const std::range_error& e) { // Store a C++ exception - SWIG_exception_impl("Tpetra::Export< LO,GO,NO >::setParameterList(Teuchos::RCP< Teuchos::ParameterList > const &)", SWIG_IndexError, e.what(), return ); + SWIG_exception_impl("Tpetra::Import< LO,GO,NO >::setParameterList(Teuchos::RCP< Teuchos::ParameterList > const &)", SWIG_IndexError, e.what(), return ); } catch (const std::exception& e) { // Store a C++ exception - SWIG_exception_impl("Tpetra::Export< LO,GO,NO >::setParameterList(Teuchos::RCP< Teuchos::ParameterList > const &)", SWIG_RuntimeError, e.what(), return ); + SWIG_exception_impl("Tpetra::Import< LO,GO,NO >::setParameterList(Teuchos::RCP< Teuchos::ParameterList > const &)", SWIG_RuntimeError, e.what(), return ); } catch (...) { - SWIG_exception_impl("Tpetra::Export< LO,GO,NO >::setParameterList(Teuchos::RCP< Teuchos::ParameterList > const &)", SWIG_UnknownError, "An unknown exception occurred", return ); + SWIG_exception_impl("Tpetra::Import< LO,GO,NO >::setParameterList(Teuchos::RCP< Teuchos::ParameterList > const &)", SWIG_UnknownError, "An unknown exception occurred", return ); } } } -SWIGEXPORT size_t _wrap_TpetraExport_getNumSameIDs(SwigClassWrapper const *farg1) { +SWIGEXPORT size_t _wrap_TpetraImport_getNumSameIDs(SwigClassWrapper const *farg1) { size_t fresult ; - Tpetra::Export< LO,GO,NO > *arg1 = (Tpetra::Export< LO,GO,NO > *) 0 ; - Teuchos::RCP< Tpetra::Export< LO,GO,NO > const > *smartarg1 ; + Tpetra::Import< LO,GO,NO > *arg1 = (Tpetra::Import< LO,GO,NO > *) 0 ; + Teuchos::RCP< Tpetra::Import< LO,GO,NO > const > *smartarg1 ; size_t result; - smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); - arg1 = smartarg1 ? const_cast< Tpetra::Export* >(smartarg1->get()) : NULL; + smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::Import* >(smartarg1->get()) : NULL; { // Make sure no unhandled exceptions exist before performing a new action - SWIG_check_unhandled_exception_impl("Tpetra::Export< LO,GO,NO >::getNumSameIDs() const");; + SWIG_check_unhandled_exception_impl("Tpetra::Import< LO,GO,NO >::getNumSameIDs() const");; try { // Attempt the wrapped function call - result = (size_t)((Tpetra::Export< LO,GO,NO > const *)arg1)->getNumSameIDs(); + result = (size_t)((Tpetra::Import< LO,GO,NO > const *)arg1)->getNumSameIDs(); } catch (const std::range_error& e) { // Store a C++ exception - SWIG_exception_impl("Tpetra::Export< LO,GO,NO >::getNumSameIDs() const", SWIG_IndexError, e.what(), return 0); + SWIG_exception_impl("Tpetra::Import< LO,GO,NO >::getNumSameIDs() const", SWIG_IndexError, e.what(), return 0); } catch (const std::exception& e) { // Store a C++ exception - SWIG_exception_impl("Tpetra::Export< LO,GO,NO >::getNumSameIDs() const", SWIG_RuntimeError, e.what(), return 0); + SWIG_exception_impl("Tpetra::Import< LO,GO,NO >::getNumSameIDs() const", SWIG_RuntimeError, e.what(), return 0); } catch (...) { - SWIG_exception_impl("Tpetra::Export< LO,GO,NO >::getNumSameIDs() const", SWIG_UnknownError, "An unknown exception occurred", return 0); + SWIG_exception_impl("Tpetra::Import< LO,GO,NO >::getNumSameIDs() const", SWIG_UnknownError, "An unknown exception occurred", return 0); } } fresult = static_cast< size_t >(result); @@ -2663,35 +2640,35 @@ SWIGEXPORT size_t _wrap_TpetraExport_getNumSameIDs(SwigClassWrapper const *farg1 } -SWIGEXPORT size_t _wrap_TpetraExport_getNumPermuteIDs(SwigClassWrapper const *farg1) { +SWIGEXPORT size_t _wrap_TpetraImport_getNumPermuteIDs(SwigClassWrapper const *farg1) { size_t fresult ; - Tpetra::Export< LO,GO,NO > *arg1 = (Tpetra::Export< LO,GO,NO > *) 0 ; - Teuchos::RCP< Tpetra::Export< LO,GO,NO > const > *smartarg1 ; + Tpetra::Import< LO,GO,NO > *arg1 = (Tpetra::Import< LO,GO,NO > *) 0 ; + Teuchos::RCP< Tpetra::Import< LO,GO,NO > const > *smartarg1 ; size_t result; - smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); - arg1 = smartarg1 ? const_cast< Tpetra::Export* >(smartarg1->get()) : NULL; + smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::Import* >(smartarg1->get()) : NULL; { // Make sure no unhandled exceptions exist before performing a new action - SWIG_check_unhandled_exception_impl("Tpetra::Export< LO,GO,NO >::getNumPermuteIDs() const");; + SWIG_check_unhandled_exception_impl("Tpetra::Import< LO,GO,NO >::getNumPermuteIDs() const");; try { // Attempt the wrapped function call - result = (size_t)((Tpetra::Export< LO,GO,NO > const *)arg1)->getNumPermuteIDs(); + result = (size_t)((Tpetra::Import< LO,GO,NO > const *)arg1)->getNumPermuteIDs(); } catch (const std::range_error& e) { // Store a C++ exception - SWIG_exception_impl("Tpetra::Export< LO,GO,NO >::getNumPermuteIDs() const", SWIG_IndexError, e.what(), return 0); + SWIG_exception_impl("Tpetra::Import< LO,GO,NO >::getNumPermuteIDs() const", SWIG_IndexError, e.what(), return 0); } catch (const std::exception& e) { // Store a C++ exception - SWIG_exception_impl("Tpetra::Export< LO,GO,NO >::getNumPermuteIDs() const", SWIG_RuntimeError, e.what(), return 0); + SWIG_exception_impl("Tpetra::Import< LO,GO,NO >::getNumPermuteIDs() const", SWIG_RuntimeError, e.what(), return 0); } catch (...) { - SWIG_exception_impl("Tpetra::Export< LO,GO,NO >::getNumPermuteIDs() const", SWIG_UnknownError, "An unknown exception occurred", return 0); + SWIG_exception_impl("Tpetra::Import< LO,GO,NO >::getNumPermuteIDs() const", SWIG_UnknownError, "An unknown exception occurred", return 0); } } fresult = static_cast< size_t >(result); @@ -2699,35 +2676,35 @@ SWIGEXPORT size_t _wrap_TpetraExport_getNumPermuteIDs(SwigClassWrapper const *fa } -SWIGEXPORT size_t _wrap_TpetraExport_getNumRemoteIDs(SwigClassWrapper const *farg1) { +SWIGEXPORT size_t _wrap_TpetraImport_getNumRemoteIDs(SwigClassWrapper const *farg1) { size_t fresult ; - Tpetra::Export< LO,GO,NO > *arg1 = (Tpetra::Export< LO,GO,NO > *) 0 ; - Teuchos::RCP< Tpetra::Export< LO,GO,NO > const > *smartarg1 ; + Tpetra::Import< LO,GO,NO > *arg1 = (Tpetra::Import< LO,GO,NO > *) 0 ; + Teuchos::RCP< Tpetra::Import< LO,GO,NO > const > *smartarg1 ; size_t result; - smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); - arg1 = smartarg1 ? const_cast< Tpetra::Export* >(smartarg1->get()) : NULL; + smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::Import* >(smartarg1->get()) : NULL; { // Make sure no unhandled exceptions exist before performing a new action - SWIG_check_unhandled_exception_impl("Tpetra::Export< LO,GO,NO >::getNumRemoteIDs() const");; + SWIG_check_unhandled_exception_impl("Tpetra::Import< LO,GO,NO >::getNumRemoteIDs() const");; try { // Attempt the wrapped function call - result = (size_t)((Tpetra::Export< LO,GO,NO > const *)arg1)->getNumRemoteIDs(); + result = (size_t)((Tpetra::Import< LO,GO,NO > const *)arg1)->getNumRemoteIDs(); } catch (const std::range_error& e) { // Store a C++ exception - SWIG_exception_impl("Tpetra::Export< LO,GO,NO >::getNumRemoteIDs() const", SWIG_IndexError, e.what(), return 0); + SWIG_exception_impl("Tpetra::Import< LO,GO,NO >::getNumRemoteIDs() const", SWIG_IndexError, e.what(), return 0); } catch (const std::exception& e) { // Store a C++ exception - SWIG_exception_impl("Tpetra::Export< LO,GO,NO >::getNumRemoteIDs() const", SWIG_RuntimeError, e.what(), return 0); + SWIG_exception_impl("Tpetra::Import< LO,GO,NO >::getNumRemoteIDs() const", SWIG_RuntimeError, e.what(), return 0); } catch (...) { - SWIG_exception_impl("Tpetra::Export< LO,GO,NO >::getNumRemoteIDs() const", SWIG_UnknownError, "An unknown exception occurred", return 0); + SWIG_exception_impl("Tpetra::Import< LO,GO,NO >::getNumRemoteIDs() const", SWIG_UnknownError, "An unknown exception occurred", return 0); } } fresult = static_cast< size_t >(result); @@ -2735,35 +2712,35 @@ SWIGEXPORT size_t _wrap_TpetraExport_getNumRemoteIDs(SwigClassWrapper const *far } -SWIGEXPORT size_t _wrap_TpetraExport_getNumExportIDs(SwigClassWrapper const *farg1) { +SWIGEXPORT size_t _wrap_TpetraImport_getNumExportIDs(SwigClassWrapper const *farg1) { size_t fresult ; - Tpetra::Export< LO,GO,NO > *arg1 = (Tpetra::Export< LO,GO,NO > *) 0 ; - Teuchos::RCP< Tpetra::Export< LO,GO,NO > const > *smartarg1 ; + Tpetra::Import< LO,GO,NO > *arg1 = (Tpetra::Import< LO,GO,NO > *) 0 ; + Teuchos::RCP< Tpetra::Import< LO,GO,NO > const > *smartarg1 ; size_t result; - smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); - arg1 = smartarg1 ? const_cast< Tpetra::Export* >(smartarg1->get()) : NULL; + smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::Import* >(smartarg1->get()) : NULL; { // Make sure no unhandled exceptions exist before performing a new action - SWIG_check_unhandled_exception_impl("Tpetra::Export< LO,GO,NO >::getNumExportIDs() const");; + SWIG_check_unhandled_exception_impl("Tpetra::Import< LO,GO,NO >::getNumExportIDs() const");; try { // Attempt the wrapped function call - result = (size_t)((Tpetra::Export< LO,GO,NO > const *)arg1)->getNumExportIDs(); + result = (size_t)((Tpetra::Import< LO,GO,NO > const *)arg1)->getNumExportIDs(); } catch (const std::range_error& e) { // Store a C++ exception - SWIG_exception_impl("Tpetra::Export< LO,GO,NO >::getNumExportIDs() const", SWIG_IndexError, e.what(), return 0); + SWIG_exception_impl("Tpetra::Import< LO,GO,NO >::getNumExportIDs() const", SWIG_IndexError, e.what(), return 0); } catch (const std::exception& e) { // Store a C++ exception - SWIG_exception_impl("Tpetra::Export< LO,GO,NO >::getNumExportIDs() const", SWIG_RuntimeError, e.what(), return 0); + SWIG_exception_impl("Tpetra::Import< LO,GO,NO >::getNumExportIDs() const", SWIG_RuntimeError, e.what(), return 0); } catch (...) { - SWIG_exception_impl("Tpetra::Export< LO,GO,NO >::getNumExportIDs() const", SWIG_UnknownError, "An unknown exception occurred", return 0); + SWIG_exception_impl("Tpetra::Import< LO,GO,NO >::getNumExportIDs() const", SWIG_UnknownError, "An unknown exception occurred", return 0); } } fresult = static_cast< size_t >(result); @@ -2771,35 +2748,35 @@ SWIGEXPORT size_t _wrap_TpetraExport_getNumExportIDs(SwigClassWrapper const *far } -SWIGEXPORT SwigClassWrapper _wrap_TpetraExport_getSourceMap(SwigClassWrapper const *farg1) { +SWIGEXPORT SwigClassWrapper _wrap_TpetraImport_getSourceMap(SwigClassWrapper const *farg1) { SwigClassWrapper fresult ; - Tpetra::Export< LO,GO,NO > *arg1 = (Tpetra::Export< LO,GO,NO > *) 0 ; - Teuchos::RCP< Tpetra::Export< LO,GO,NO > const > *smartarg1 ; - Teuchos::RCP< Tpetra::Export< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > result; + Tpetra::Import< LO,GO,NO > *arg1 = (Tpetra::Import< LO,GO,NO > *) 0 ; + Teuchos::RCP< Tpetra::Import< LO,GO,NO > const > *smartarg1 ; + Teuchos::RCP< Tpetra::Import< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > result; - smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); - arg1 = smartarg1 ? const_cast< Tpetra::Export* >(smartarg1->get()) : NULL; + smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::Import* >(smartarg1->get()) : NULL; { // Make sure no unhandled exceptions exist before performing a new action - SWIG_check_unhandled_exception_impl("Tpetra::Export< LO,GO,NO >::getSourceMap() const");; + SWIG_check_unhandled_exception_impl("Tpetra::Import< LO,GO,NO >::getSourceMap() const");; try { // Attempt the wrapped function call - result = ((Tpetra::Export< LO,GO,NO > const *)arg1)->getSourceMap(); + result = ((Tpetra::Import< LO,GO,NO > const *)arg1)->getSourceMap(); } catch (const std::range_error& e) { // Store a C++ exception - SWIG_exception_impl("Tpetra::Export< LO,GO,NO >::getSourceMap() const", SWIG_IndexError, e.what(), return SwigClassWrapper_uninitialized()); + SWIG_exception_impl("Tpetra::Import< LO,GO,NO >::getSourceMap() const", SWIG_IndexError, e.what(), return SwigClassWrapper_uninitialized()); } catch (const std::exception& e) { // Store a C++ exception - SWIG_exception_impl("Tpetra::Export< LO,GO,NO >::getSourceMap() const", SWIG_RuntimeError, e.what(), return SwigClassWrapper_uninitialized()); + SWIG_exception_impl("Tpetra::Import< LO,GO,NO >::getSourceMap() const", SWIG_RuntimeError, e.what(), return SwigClassWrapper_uninitialized()); } catch (...) { - SWIG_exception_impl("Tpetra::Export< LO,GO,NO >::getSourceMap() const", SWIG_UnknownError, "An unknown exception occurred", return SwigClassWrapper_uninitialized()); + SWIG_exception_impl("Tpetra::Import< LO,GO,NO >::getSourceMap() const", SWIG_UnknownError, "An unknown exception occurred", return SwigClassWrapper_uninitialized()); } } fresult.cptr = (new Teuchos::RCP >(static_cast< const Teuchos::RCP >& >(result))); @@ -2808,35 +2785,35 @@ SWIGEXPORT SwigClassWrapper _wrap_TpetraExport_getSourceMap(SwigClassWrapper con } -SWIGEXPORT SwigClassWrapper _wrap_TpetraExport_getTargetMap(SwigClassWrapper const *farg1) { +SWIGEXPORT SwigClassWrapper _wrap_TpetraImport_getTargetMap(SwigClassWrapper const *farg1) { SwigClassWrapper fresult ; - Tpetra::Export< LO,GO,NO > *arg1 = (Tpetra::Export< LO,GO,NO > *) 0 ; - Teuchos::RCP< Tpetra::Export< LO,GO,NO > const > *smartarg1 ; - Teuchos::RCP< Tpetra::Export< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > result; + Tpetra::Import< LO,GO,NO > *arg1 = (Tpetra::Import< LO,GO,NO > *) 0 ; + Teuchos::RCP< Tpetra::Import< LO,GO,NO > const > *smartarg1 ; + Teuchos::RCP< Tpetra::Import< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > result; - smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); - arg1 = smartarg1 ? const_cast< Tpetra::Export* >(smartarg1->get()) : NULL; + smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::Import* >(smartarg1->get()) : NULL; { // Make sure no unhandled exceptions exist before performing a new action - SWIG_check_unhandled_exception_impl("Tpetra::Export< LO,GO,NO >::getTargetMap() const");; + SWIG_check_unhandled_exception_impl("Tpetra::Import< LO,GO,NO >::getTargetMap() const");; try { // Attempt the wrapped function call - result = ((Tpetra::Export< LO,GO,NO > const *)arg1)->getTargetMap(); + result = ((Tpetra::Import< LO,GO,NO > const *)arg1)->getTargetMap(); } catch (const std::range_error& e) { // Store a C++ exception - SWIG_exception_impl("Tpetra::Export< LO,GO,NO >::getTargetMap() const", SWIG_IndexError, e.what(), return SwigClassWrapper_uninitialized()); + SWIG_exception_impl("Tpetra::Import< LO,GO,NO >::getTargetMap() const", SWIG_IndexError, e.what(), return SwigClassWrapper_uninitialized()); } catch (const std::exception& e) { // Store a C++ exception - SWIG_exception_impl("Tpetra::Export< LO,GO,NO >::getTargetMap() const", SWIG_RuntimeError, e.what(), return SwigClassWrapper_uninitialized()); + SWIG_exception_impl("Tpetra::Import< LO,GO,NO >::getTargetMap() const", SWIG_RuntimeError, e.what(), return SwigClassWrapper_uninitialized()); } catch (...) { - SWIG_exception_impl("Tpetra::Export< LO,GO,NO >::getTargetMap() const", SWIG_UnknownError, "An unknown exception occurred", return SwigClassWrapper_uninitialized()); + SWIG_exception_impl("Tpetra::Import< LO,GO,NO >::getTargetMap() const", SWIG_UnknownError, "An unknown exception occurred", return SwigClassWrapper_uninitialized()); } } fresult.cptr = (new Teuchos::RCP >(static_cast< const Teuchos::RCP >& >(result))); @@ -2845,35 +2822,35 @@ SWIGEXPORT SwigClassWrapper _wrap_TpetraExport_getTargetMap(SwigClassWrapper con } -SWIGEXPORT int _wrap_TpetraExport_isLocallyComplete(SwigClassWrapper const *farg1) { +SWIGEXPORT int _wrap_TpetraImport_isLocallyComplete(SwigClassWrapper const *farg1) { int fresult ; - Tpetra::Export< LO,GO,NO > *arg1 = (Tpetra::Export< LO,GO,NO > *) 0 ; - Teuchos::RCP< Tpetra::Export< LO,GO,NO > const > *smartarg1 ; + Tpetra::Import< LO,GO,NO > *arg1 = (Tpetra::Import< LO,GO,NO > *) 0 ; + Teuchos::RCP< Tpetra::Import< LO,GO,NO > const > *smartarg1 ; bool result; - smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); - arg1 = smartarg1 ? const_cast< Tpetra::Export* >(smartarg1->get()) : NULL; + smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::Import* >(smartarg1->get()) : NULL; { // Make sure no unhandled exceptions exist before performing a new action - SWIG_check_unhandled_exception_impl("Tpetra::Export< LO,GO,NO >::isLocallyComplete() const");; + SWIG_check_unhandled_exception_impl("Tpetra::Import< LO,GO,NO >::isLocallyComplete() const");; try { // Attempt the wrapped function call - result = (bool)((Tpetra::Export< LO,GO,NO > const *)arg1)->isLocallyComplete(); + result = (bool)((Tpetra::Import< LO,GO,NO > const *)arg1)->isLocallyComplete(); } catch (const std::range_error& e) { // Store a C++ exception - SWIG_exception_impl("Tpetra::Export< LO,GO,NO >::isLocallyComplete() const", SWIG_IndexError, e.what(), return 0); + SWIG_exception_impl("Tpetra::Import< LO,GO,NO >::isLocallyComplete() const", SWIG_IndexError, e.what(), return 0); } catch (const std::exception& e) { // Store a C++ exception - SWIG_exception_impl("Tpetra::Export< LO,GO,NO >::isLocallyComplete() const", SWIG_RuntimeError, e.what(), return 0); + SWIG_exception_impl("Tpetra::Import< LO,GO,NO >::isLocallyComplete() const", SWIG_RuntimeError, e.what(), return 0); } catch (...) { - SWIG_exception_impl("Tpetra::Export< LO,GO,NO >::isLocallyComplete() const", SWIG_UnknownError, "An unknown exception occurred", return 0); + SWIG_exception_impl("Tpetra::Import< LO,GO,NO >::isLocallyComplete() const", SWIG_UnknownError, "An unknown exception occurred", return 0); } } fresult = (result ? 1 : 0); @@ -2881,377 +2858,388 @@ SWIGEXPORT int _wrap_TpetraExport_isLocallyComplete(SwigClassWrapper const *farg } -SWIGEXPORT void _wrap_assign_TpetraExport(SwigClassWrapper * self, SwigClassWrapper const * other) { - typedef Teuchos::RCP< Tpetra::Export > swig_lhs_classtype; - SWIG_assign(swig_lhs_classtype, self, - swig_lhs_classtype, const_cast(other), - 0 | swig::IS_DESTR | swig::IS_COPY_CONSTR | swig::IS_COPY_ASSIGN); -} - - -SWIGEXPORT SwigClassWrapper _wrap_new_TpetraImport__SWIG_0(SwigClassWrapper const *farg1, SwigClassWrapper const *farg2) { +SWIGEXPORT SwigClassWrapper _wrap_TpetraImport_setUnion__SWIG_0(SwigClassWrapper const *farg1, SwigClassWrapper const *farg2) { SwigClassWrapper fresult ; - Teuchos::RCP< Tpetra::Import< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > *arg1 = 0 ; - Teuchos::RCP< Tpetra::Import< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > *arg2 = 0 ; - Teuchos::RCP< Tpetra::Import< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > tempnull1 ; - Teuchos::RCP< Tpetra::Import< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > tempnull2 ; - Tpetra::Import< LO,GO,NO > *result = 0 ; + Tpetra::Import< LO,GO,NO > *arg1 = (Tpetra::Import< LO,GO,NO > *) 0 ; + Tpetra::Import< int,long long,Kokkos::Compat::KokkosSerialWrapperNode > *arg2 = 0 ; + Teuchos::RCP< Tpetra::Import< LO,GO,NO > const > *smartarg1 ; + Teuchos::RCP< Tpetra::Import< LO,GO,NO > const > *smartarg2 ; + Teuchos::RCP< Tpetra::Import< int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const > result; - arg1 = farg1->cptr ? static_cast< Teuchos::RCP< Tpetra::Import< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg1->cptr) : &tempnull1; - arg2 = farg2->cptr ? static_cast< Teuchos::RCP< Tpetra::Import< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg2->cptr) : &tempnull2; + smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::Import* >(smartarg1->get()) : NULL; + SWIG_check_sp_nonnull(farg2, "Tpetra::Import< int,long long,Kokkos::Compat::KokkosSerialWrapperNode > *", "TpetraImport", "Tpetra::Import< LO,GO,NO >::setUnion(Tpetra::Import< int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &) const", return SwigClassWrapper_uninitialized()) + smartarg2 = static_cast< Teuchos::RCP >* >(farg2->cptr); + arg2 = const_cast< Tpetra::Import* >(smartarg2->get()); { // Make sure no unhandled exceptions exist before performing a new action - SWIG_check_unhandled_exception_impl("Tpetra::Import< LO,GO,NO >::Import(Teuchos::RCP< Tpetra::Import< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::Import< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &)");; + SWIG_check_unhandled_exception_impl("Tpetra::Import< LO,GO,NO >::setUnion(Tpetra::Import< int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &) const");; try { // Attempt the wrapped function call - result = (Tpetra::Import< LO,GO,NO > *)new Tpetra::Import< LO,GO,NO >((Teuchos::RCP< Tpetra::Import< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &)*arg1,(Teuchos::RCP< Tpetra::Import< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &)*arg2); + result = ((Tpetra::Import< LO,GO,NO > const *)arg1)->setUnion((Tpetra::Import< int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &)*arg2); } catch (const std::range_error& e) { // Store a C++ exception - SWIG_exception_impl("Tpetra::Import< LO,GO,NO >::Import(Teuchos::RCP< Tpetra::Import< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::Import< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &)", SWIG_IndexError, e.what(), return SwigClassWrapper_uninitialized()); + SWIG_exception_impl("Tpetra::Import< LO,GO,NO >::setUnion(Tpetra::Import< int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &) const", SWIG_IndexError, e.what(), return SwigClassWrapper_uninitialized()); } catch (const std::exception& e) { // Store a C++ exception - SWIG_exception_impl("Tpetra::Import< LO,GO,NO >::Import(Teuchos::RCP< Tpetra::Import< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::Import< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &)", SWIG_RuntimeError, e.what(), return SwigClassWrapper_uninitialized()); + SWIG_exception_impl("Tpetra::Import< LO,GO,NO >::setUnion(Tpetra::Import< int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &) const", SWIG_RuntimeError, e.what(), return SwigClassWrapper_uninitialized()); } catch (...) { - SWIG_exception_impl("Tpetra::Import< LO,GO,NO >::Import(Teuchos::RCP< Tpetra::Import< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::Import< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &)", SWIG_UnknownError, "An unknown exception occurred", return SwigClassWrapper_uninitialized()); + SWIG_exception_impl("Tpetra::Import< LO,GO,NO >::setUnion(Tpetra::Import< int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &) const", SWIG_UnknownError, "An unknown exception occurred", return SwigClassWrapper_uninitialized()); } } - fresult.cptr = result ? new Teuchos::RCP< Tpetra::Import >(result SWIG_NO_NULL_DELETER_1) : NULL; + fresult.cptr = (new Teuchos::RCP >(static_cast< const Teuchos::RCP >& >(result))); fresult.mem = SWIG_MOVE; return fresult; } -SWIGEXPORT SwigClassWrapper _wrap_new_TpetraImport__SWIG_1(SwigClassWrapper const *farg1, SwigClassWrapper const *farg2, SwigClassWrapper const *farg3) { +SWIGEXPORT SwigClassWrapper _wrap_TpetraImport_setUnion__SWIG_1(SwigClassWrapper const *farg1) { SwigClassWrapper fresult ; - Teuchos::RCP< Tpetra::Import< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > *arg1 = 0 ; - Teuchos::RCP< Tpetra::Import< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > *arg2 = 0 ; - Teuchos::RCP< Teuchos::ParameterList > *arg3 = 0 ; - Teuchos::RCP< Tpetra::Import< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > tempnull1 ; - Teuchos::RCP< Tpetra::Import< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > tempnull2 ; - Teuchos::RCP< Teuchos::ParameterList > tempnull3 ; - Tpetra::Import< LO,GO,NO > *result = 0 ; + Tpetra::Import< LO,GO,NO > *arg1 = (Tpetra::Import< LO,GO,NO > *) 0 ; + Teuchos::RCP< Tpetra::Import< LO,GO,NO > const > *smartarg1 ; + Teuchos::RCP< Tpetra::Import< int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const > result; - arg1 = farg1->cptr ? static_cast< Teuchos::RCP< Tpetra::Import< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg1->cptr) : &tempnull1; - arg2 = farg2->cptr ? static_cast< Teuchos::RCP< Tpetra::Import< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg2->cptr) : &tempnull2; - arg3 = farg3->cptr ? static_cast< Teuchos::RCP< Teuchos::ParameterList > * >(farg3->cptr) : &tempnull3; + smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::Import* >(smartarg1->get()) : NULL; { // Make sure no unhandled exceptions exist before performing a new action - SWIG_check_unhandled_exception_impl("Tpetra::Import< LO,GO,NO >::Import(Teuchos::RCP< Tpetra::Import< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::Import< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Teuchos::ParameterList > const &)");; + SWIG_check_unhandled_exception_impl("Tpetra::Import< LO,GO,NO >::setUnion() const");; try { // Attempt the wrapped function call - result = (Tpetra::Import< LO,GO,NO > *)new Tpetra::Import< LO,GO,NO >((Teuchos::RCP< Tpetra::Import< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &)*arg1,(Teuchos::RCP< Tpetra::Import< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &)*arg2,(Teuchos::RCP< Teuchos::ParameterList > const &)*arg3); + result = ((Tpetra::Import< LO,GO,NO > const *)arg1)->setUnion(); } catch (const std::range_error& e) { // Store a C++ exception - SWIG_exception_impl("Tpetra::Import< LO,GO,NO >::Import(Teuchos::RCP< Tpetra::Import< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::Import< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Teuchos::ParameterList > const &)", SWIG_IndexError, e.what(), return SwigClassWrapper_uninitialized()); + SWIG_exception_impl("Tpetra::Import< LO,GO,NO >::setUnion() const", SWIG_IndexError, e.what(), return SwigClassWrapper_uninitialized()); } catch (const std::exception& e) { // Store a C++ exception - SWIG_exception_impl("Tpetra::Import< LO,GO,NO >::Import(Teuchos::RCP< Tpetra::Import< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::Import< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Teuchos::ParameterList > const &)", SWIG_RuntimeError, e.what(), return SwigClassWrapper_uninitialized()); + SWIG_exception_impl("Tpetra::Import< LO,GO,NO >::setUnion() const", SWIG_RuntimeError, e.what(), return SwigClassWrapper_uninitialized()); } catch (...) { - SWIG_exception_impl("Tpetra::Import< LO,GO,NO >::Import(Teuchos::RCP< Tpetra::Import< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::Import< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Teuchos::ParameterList > const &)", SWIG_UnknownError, "An unknown exception occurred", return SwigClassWrapper_uninitialized()); + SWIG_exception_impl("Tpetra::Import< LO,GO,NO >::setUnion() const", SWIG_UnknownError, "An unknown exception occurred", return SwigClassWrapper_uninitialized()); } } - fresult.cptr = result ? new Teuchos::RCP< Tpetra::Import >(result SWIG_NO_NULL_DELETER_1) : NULL; + fresult.cptr = (new Teuchos::RCP >(static_cast< const Teuchos::RCP >& >(result))); fresult.mem = SWIG_MOVE; return fresult; } -SWIGEXPORT SwigClassWrapper _wrap_new_TpetraImport__SWIG_2(SwigClassWrapper const *farg1) { +SWIGEXPORT SwigClassWrapper _wrap_TpetraImport_createRemoteOnlyImport(SwigClassWrapper const *farg1, SwigClassWrapper const *farg2) { SwigClassWrapper fresult ; - Tpetra::Import< int,long long,Kokkos::Compat::KokkosSerialWrapperNode > *arg1 = 0 ; + Tpetra::Import< LO,GO,NO > *arg1 = (Tpetra::Import< LO,GO,NO > *) 0 ; + Teuchos::RCP< Tpetra::Import< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > *arg2 = 0 ; Teuchos::RCP< Tpetra::Import< LO,GO,NO > const > *smartarg1 ; - Tpetra::Import< LO,GO,NO > *result = 0 ; + Teuchos::RCP< Tpetra::Import< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > tempnull2 ; + Teuchos::RCP< Tpetra::Import< int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const > result; - SWIG_check_sp_nonnull(farg1, "Tpetra::Import< int,long long,Kokkos::Compat::KokkosSerialWrapperNode > *", "TpetraImport", "Tpetra::Import< LO,GO,NO >::Import(Tpetra::Import< int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &)", return SwigClassWrapper_uninitialized()) smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); - arg1 = const_cast< Tpetra::Import* >(smartarg1->get()); + arg1 = smartarg1 ? const_cast< Tpetra::Import* >(smartarg1->get()) : NULL; + arg2 = farg2->cptr ? static_cast< Teuchos::RCP< Tpetra::Import< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg2->cptr) : &tempnull2; { // Make sure no unhandled exceptions exist before performing a new action - SWIG_check_unhandled_exception_impl("Tpetra::Import< LO,GO,NO >::Import(Tpetra::Import< int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &)");; + SWIG_check_unhandled_exception_impl("Tpetra::Import< LO,GO,NO >::createRemoteOnlyImport(Teuchos::RCP< Tpetra::Import< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &) const");; try { // Attempt the wrapped function call - result = (Tpetra::Import< LO,GO,NO > *)new Tpetra::Import< LO,GO,NO >((Tpetra::Import< int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &)*arg1); + result = ((Tpetra::Import< LO,GO,NO > const *)arg1)->createRemoteOnlyImport((Teuchos::RCP< Tpetra::Import< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &)*arg2); } catch (const std::range_error& e) { // Store a C++ exception - SWIG_exception_impl("Tpetra::Import< LO,GO,NO >::Import(Tpetra::Import< int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &)", SWIG_IndexError, e.what(), return SwigClassWrapper_uninitialized()); + SWIG_exception_impl("Tpetra::Import< LO,GO,NO >::createRemoteOnlyImport(Teuchos::RCP< Tpetra::Import< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &) const", SWIG_IndexError, e.what(), return SwigClassWrapper_uninitialized()); } catch (const std::exception& e) { // Store a C++ exception - SWIG_exception_impl("Tpetra::Import< LO,GO,NO >::Import(Tpetra::Import< int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &)", SWIG_RuntimeError, e.what(), return SwigClassWrapper_uninitialized()); + SWIG_exception_impl("Tpetra::Import< LO,GO,NO >::createRemoteOnlyImport(Teuchos::RCP< Tpetra::Import< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &) const", SWIG_RuntimeError, e.what(), return SwigClassWrapper_uninitialized()); } catch (...) { - SWIG_exception_impl("Tpetra::Import< LO,GO,NO >::Import(Tpetra::Import< int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &)", SWIG_UnknownError, "An unknown exception occurred", return SwigClassWrapper_uninitialized()); + SWIG_exception_impl("Tpetra::Import< LO,GO,NO >::createRemoteOnlyImport(Teuchos::RCP< Tpetra::Import< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &) const", SWIG_UnknownError, "An unknown exception occurred", return SwigClassWrapper_uninitialized()); } } - fresult.cptr = result ? new Teuchos::RCP< Tpetra::Import >(result SWIG_NO_NULL_DELETER_1) : NULL; + fresult.cptr = (new Teuchos::RCP >(static_cast< const Teuchos::RCP >& >(result))); fresult.mem = SWIG_MOVE; return fresult; } -SWIGEXPORT SwigClassWrapper _wrap_new_TpetraImport__SWIG_3(SwigClassWrapper const *farg1) { +SWIGEXPORT void _wrap_assign_TpetraImport(SwigClassWrapper * self, SwigClassWrapper const * other) { + typedef Teuchos::RCP< Tpetra::Import > swig_lhs_classtype; + SWIG_assign(swig_lhs_classtype, self, + swig_lhs_classtype, const_cast(other), + 0 | swig::IS_DESTR | swig::IS_COPY_CONSTR | swig::IS_COPY_ASSIGN); +} + + +SWIGEXPORT SwigClassWrapper _wrap_new_TpetraExport__SWIG_0(SwigClassWrapper const *farg1, SwigClassWrapper const *farg2) { SwigClassWrapper fresult ; - Tpetra::Export< int,long long,Kokkos::Compat::KokkosSerialWrapperNode > *arg1 = 0 ; - Teuchos::RCP< Tpetra::Export< LO,GO,NO > const > *smartarg1 ; - Tpetra::Import< LO,GO,NO > *result = 0 ; + Teuchos::RCP< Tpetra::Export< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > *arg1 = 0 ; + Teuchos::RCP< Tpetra::Export< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > *arg2 = 0 ; + Teuchos::RCP< Tpetra::Export< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > tempnull1 ; + Teuchos::RCP< Tpetra::Export< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > tempnull2 ; + Tpetra::Export< LO,GO,NO > *result = 0 ; - SWIG_check_sp_nonnull(farg1, "Tpetra::Export< int,long long,Kokkos::Compat::KokkosSerialWrapperNode > *", "TpetraExport", "Tpetra::Import< LO,GO,NO >::Import(Tpetra::Export< int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &)", return SwigClassWrapper_uninitialized()) - smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); - arg1 = const_cast< Tpetra::Export* >(smartarg1->get()); + arg1 = farg1->cptr ? static_cast< Teuchos::RCP< Tpetra::Export< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg1->cptr) : &tempnull1; + arg2 = farg2->cptr ? static_cast< Teuchos::RCP< Tpetra::Export< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg2->cptr) : &tempnull2; { // Make sure no unhandled exceptions exist before performing a new action - SWIG_check_unhandled_exception_impl("Tpetra::Import< LO,GO,NO >::Import(Tpetra::Export< int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &)");; + SWIG_check_unhandled_exception_impl("Tpetra::Export< LO,GO,NO >::Export(Teuchos::RCP< Tpetra::Export< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::Export< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &)");; try { // Attempt the wrapped function call - result = (Tpetra::Import< LO,GO,NO > *)new Tpetra::Import< LO,GO,NO >((Tpetra::Export< int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &)*arg1); + result = (Tpetra::Export< LO,GO,NO > *)new Tpetra::Export< LO,GO,NO >((Teuchos::RCP< Tpetra::Export< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &)*arg1,(Teuchos::RCP< Tpetra::Export< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &)*arg2); } catch (const std::range_error& e) { // Store a C++ exception - SWIG_exception_impl("Tpetra::Import< LO,GO,NO >::Import(Tpetra::Export< int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &)", SWIG_IndexError, e.what(), return SwigClassWrapper_uninitialized()); + SWIG_exception_impl("Tpetra::Export< LO,GO,NO >::Export(Teuchos::RCP< Tpetra::Export< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::Export< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &)", SWIG_IndexError, e.what(), return SwigClassWrapper_uninitialized()); } catch (const std::exception& e) { // Store a C++ exception - SWIG_exception_impl("Tpetra::Import< LO,GO,NO >::Import(Tpetra::Export< int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &)", SWIG_RuntimeError, e.what(), return SwigClassWrapper_uninitialized()); + SWIG_exception_impl("Tpetra::Export< LO,GO,NO >::Export(Teuchos::RCP< Tpetra::Export< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::Export< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &)", SWIG_RuntimeError, e.what(), return SwigClassWrapper_uninitialized()); } catch (...) { - SWIG_exception_impl("Tpetra::Import< LO,GO,NO >::Import(Tpetra::Export< int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &)", SWIG_UnknownError, "An unknown exception occurred", return SwigClassWrapper_uninitialized()); + SWIG_exception_impl("Tpetra::Export< LO,GO,NO >::Export(Teuchos::RCP< Tpetra::Export< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::Export< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &)", SWIG_UnknownError, "An unknown exception occurred", return SwigClassWrapper_uninitialized()); } } - fresult.cptr = result ? new Teuchos::RCP< Tpetra::Import >(result SWIG_NO_NULL_DELETER_1) : NULL; + fresult.cptr = result ? new Teuchos::RCP< Tpetra::Export >(result SWIG_NO_NULL_DELETER_1) : NULL; fresult.mem = SWIG_MOVE; return fresult; } -SWIGEXPORT void _wrap_delete_TpetraImport(SwigClassWrapper const *farg1) { - Tpetra::Import< LO,GO,NO > *arg1 = (Tpetra::Import< LO,GO,NO > *) 0 ; - Teuchos::RCP< Tpetra::Import< LO,GO,NO > > *smartarg1 ; +SWIGEXPORT SwigClassWrapper _wrap_new_TpetraExport__SWIG_1(SwigClassWrapper const *farg1, SwigClassWrapper const *farg2, SwigClassWrapper const *farg3) { + SwigClassWrapper fresult ; + Teuchos::RCP< Tpetra::Export< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > *arg1 = 0 ; + Teuchos::RCP< Tpetra::Export< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > *arg2 = 0 ; + Teuchos::RCP< Teuchos::ParameterList > *arg3 = 0 ; + Teuchos::RCP< Tpetra::Export< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > tempnull1 ; + Teuchos::RCP< Tpetra::Export< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > tempnull2 ; + Teuchos::RCP< Teuchos::ParameterList > tempnull3 ; + Tpetra::Export< LO,GO,NO > *result = 0 ; - smartarg1 = static_cast< Teuchos::RCP< Tpetra::Import >* >(farg1->cptr); - arg1 = smartarg1 ? const_cast< Tpetra::Import* >(smartarg1->get()) : NULL; + arg1 = farg1->cptr ? static_cast< Teuchos::RCP< Tpetra::Export< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg1->cptr) : &tempnull1; + arg2 = farg2->cptr ? static_cast< Teuchos::RCP< Tpetra::Export< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg2->cptr) : &tempnull2; + arg3 = farg3->cptr ? static_cast< Teuchos::RCP< Teuchos::ParameterList > * >(farg3->cptr) : &tempnull3; { // Make sure no unhandled exceptions exist before performing a new action - SWIG_check_unhandled_exception_impl("Tpetra::Import< LO,GO,NO >::~Import()");; + SWIG_check_unhandled_exception_impl("Tpetra::Export< LO,GO,NO >::Export(Teuchos::RCP< Tpetra::Export< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::Export< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Teuchos::ParameterList > const &)");; try { // Attempt the wrapped function call - (void)arg1; delete smartarg1; + result = (Tpetra::Export< LO,GO,NO > *)new Tpetra::Export< LO,GO,NO >((Teuchos::RCP< Tpetra::Export< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &)*arg1,(Teuchos::RCP< Tpetra::Export< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &)*arg2,(Teuchos::RCP< Teuchos::ParameterList > const &)*arg3); } catch (const std::range_error& e) { // Store a C++ exception - SWIG_exception_impl("Tpetra::Import< LO,GO,NO >::~Import()", SWIG_IndexError, e.what(), return ); + SWIG_exception_impl("Tpetra::Export< LO,GO,NO >::Export(Teuchos::RCP< Tpetra::Export< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::Export< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Teuchos::ParameterList > const &)", SWIG_IndexError, e.what(), return SwigClassWrapper_uninitialized()); } catch (const std::exception& e) { // Store a C++ exception - SWIG_exception_impl("Tpetra::Import< LO,GO,NO >::~Import()", SWIG_RuntimeError, e.what(), return ); + SWIG_exception_impl("Tpetra::Export< LO,GO,NO >::Export(Teuchos::RCP< Tpetra::Export< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::Export< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Teuchos::ParameterList > const &)", SWIG_RuntimeError, e.what(), return SwigClassWrapper_uninitialized()); } catch (...) { - SWIG_exception_impl("Tpetra::Import< LO,GO,NO >::~Import()", SWIG_UnknownError, "An unknown exception occurred", return ); + SWIG_exception_impl("Tpetra::Export< LO,GO,NO >::Export(Teuchos::RCP< Tpetra::Export< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::Export< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Teuchos::ParameterList > const &)", SWIG_UnknownError, "An unknown exception occurred", return SwigClassWrapper_uninitialized()); } } - + fresult.cptr = result ? new Teuchos::RCP< Tpetra::Export >(result SWIG_NO_NULL_DELETER_1) : NULL; + fresult.mem = SWIG_MOVE; + return fresult; } -SWIGEXPORT void _wrap_TpetraImport_setParameterList(SwigClassWrapper const *farg1, SwigClassWrapper const *farg2) { - Tpetra::Import< LO,GO,NO > *arg1 = (Tpetra::Import< LO,GO,NO > *) 0 ; - Teuchos::RCP< Teuchos::ParameterList > *arg2 = 0 ; - Teuchos::RCP< Tpetra::Import< LO,GO,NO > > *smartarg1 ; - Teuchos::RCP< Teuchos::ParameterList > tempnull2 ; +SWIGEXPORT SwigClassWrapper _wrap_new_TpetraExport__SWIG_2(SwigClassWrapper const *farg1) { + SwigClassWrapper fresult ; + Tpetra::Export< int,long long,Kokkos::Compat::KokkosSerialWrapperNode > *arg1 = 0 ; + Teuchos::RCP< Tpetra::Export< LO,GO,NO > const > *smartarg1 ; + Tpetra::Export< LO,GO,NO > *result = 0 ; - smartarg1 = static_cast< Teuchos::RCP< Tpetra::Import >* >(farg1->cptr); - arg1 = smartarg1 ? const_cast< Tpetra::Import* >(smartarg1->get()) : NULL; - arg2 = farg2->cptr ? static_cast< Teuchos::RCP< Teuchos::ParameterList > * >(farg2->cptr) : &tempnull2; + SWIG_check_sp_nonnull(farg1, "Tpetra::Export< int,long long,Kokkos::Compat::KokkosSerialWrapperNode > *", "TpetraExport", "Tpetra::Export< LO,GO,NO >::Export(Tpetra::Export< int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &)", return SwigClassWrapper_uninitialized()) + smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); + arg1 = const_cast< Tpetra::Export* >(smartarg1->get()); { // Make sure no unhandled exceptions exist before performing a new action - SWIG_check_unhandled_exception_impl("Tpetra::Import< LO,GO,NO >::setParameterList(Teuchos::RCP< Teuchos::ParameterList > const &)");; + SWIG_check_unhandled_exception_impl("Tpetra::Export< LO,GO,NO >::Export(Tpetra::Export< int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &)");; try { // Attempt the wrapped function call - (arg1)->setParameterList((Teuchos::RCP< Teuchos::ParameterList > const &)*arg2); + result = (Tpetra::Export< LO,GO,NO > *)new Tpetra::Export< LO,GO,NO >((Tpetra::Export< int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &)*arg1); } catch (const std::range_error& e) { // Store a C++ exception - SWIG_exception_impl("Tpetra::Import< LO,GO,NO >::setParameterList(Teuchos::RCP< Teuchos::ParameterList > const &)", SWIG_IndexError, e.what(), return ); + SWIG_exception_impl("Tpetra::Export< LO,GO,NO >::Export(Tpetra::Export< int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &)", SWIG_IndexError, e.what(), return SwigClassWrapper_uninitialized()); } catch (const std::exception& e) { // Store a C++ exception - SWIG_exception_impl("Tpetra::Import< LO,GO,NO >::setParameterList(Teuchos::RCP< Teuchos::ParameterList > const &)", SWIG_RuntimeError, e.what(), return ); + SWIG_exception_impl("Tpetra::Export< LO,GO,NO >::Export(Tpetra::Export< int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &)", SWIG_RuntimeError, e.what(), return SwigClassWrapper_uninitialized()); } catch (...) { - SWIG_exception_impl("Tpetra::Import< LO,GO,NO >::setParameterList(Teuchos::RCP< Teuchos::ParameterList > const &)", SWIG_UnknownError, "An unknown exception occurred", return ); + SWIG_exception_impl("Tpetra::Export< LO,GO,NO >::Export(Tpetra::Export< int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &)", SWIG_UnknownError, "An unknown exception occurred", return SwigClassWrapper_uninitialized()); } } - + fresult.cptr = result ? new Teuchos::RCP< Tpetra::Export >(result SWIG_NO_NULL_DELETER_1) : NULL; + fresult.mem = SWIG_MOVE; + return fresult; } -SWIGEXPORT size_t _wrap_TpetraImport_getNumSameIDs(SwigClassWrapper const *farg1) { - size_t fresult ; - Tpetra::Import< LO,GO,NO > *arg1 = (Tpetra::Import< LO,GO,NO > *) 0 ; +SWIGEXPORT SwigClassWrapper _wrap_new_TpetraExport__SWIG_3(SwigClassWrapper const *farg1) { + SwigClassWrapper fresult ; + Tpetra::Import< int,long long,Kokkos::Compat::KokkosSerialWrapperNode > *arg1 = 0 ; Teuchos::RCP< Tpetra::Import< LO,GO,NO > const > *smartarg1 ; - size_t result; + Tpetra::Export< LO,GO,NO > *result = 0 ; + SWIG_check_sp_nonnull(farg1, "Tpetra::Import< int,long long,Kokkos::Compat::KokkosSerialWrapperNode > *", "TpetraImport", "Tpetra::Export< LO,GO,NO >::Export(Tpetra::Import< int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &)", return SwigClassWrapper_uninitialized()) smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); - arg1 = smartarg1 ? const_cast< Tpetra::Import* >(smartarg1->get()) : NULL; + arg1 = const_cast< Tpetra::Import* >(smartarg1->get()); { // Make sure no unhandled exceptions exist before performing a new action - SWIG_check_unhandled_exception_impl("Tpetra::Import< LO,GO,NO >::getNumSameIDs() const");; + SWIG_check_unhandled_exception_impl("Tpetra::Export< LO,GO,NO >::Export(Tpetra::Import< int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &)");; try { // Attempt the wrapped function call - result = (size_t)((Tpetra::Import< LO,GO,NO > const *)arg1)->getNumSameIDs(); + result = (Tpetra::Export< LO,GO,NO > *)new Tpetra::Export< LO,GO,NO >((Tpetra::Import< int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &)*arg1); } catch (const std::range_error& e) { // Store a C++ exception - SWIG_exception_impl("Tpetra::Import< LO,GO,NO >::getNumSameIDs() const", SWIG_IndexError, e.what(), return 0); + SWIG_exception_impl("Tpetra::Export< LO,GO,NO >::Export(Tpetra::Import< int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &)", SWIG_IndexError, e.what(), return SwigClassWrapper_uninitialized()); } catch (const std::exception& e) { // Store a C++ exception - SWIG_exception_impl("Tpetra::Import< LO,GO,NO >::getNumSameIDs() const", SWIG_RuntimeError, e.what(), return 0); + SWIG_exception_impl("Tpetra::Export< LO,GO,NO >::Export(Tpetra::Import< int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &)", SWIG_RuntimeError, e.what(), return SwigClassWrapper_uninitialized()); } catch (...) { - SWIG_exception_impl("Tpetra::Import< LO,GO,NO >::getNumSameIDs() const", SWIG_UnknownError, "An unknown exception occurred", return 0); + SWIG_exception_impl("Tpetra::Export< LO,GO,NO >::Export(Tpetra::Import< int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &)", SWIG_UnknownError, "An unknown exception occurred", return SwigClassWrapper_uninitialized()); } } - fresult = static_cast< size_t >(result); + fresult.cptr = result ? new Teuchos::RCP< Tpetra::Export >(result SWIG_NO_NULL_DELETER_1) : NULL; + fresult.mem = SWIG_MOVE; return fresult; } -SWIGEXPORT size_t _wrap_TpetraImport_getNumPermuteIDs(SwigClassWrapper const *farg1) { - size_t fresult ; - Tpetra::Import< LO,GO,NO > *arg1 = (Tpetra::Import< LO,GO,NO > *) 0 ; - Teuchos::RCP< Tpetra::Import< LO,GO,NO > const > *smartarg1 ; - size_t result; +SWIGEXPORT void _wrap_delete_TpetraExport(SwigClassWrapper const *farg1) { + Tpetra::Export< LO,GO,NO > *arg1 = (Tpetra::Export< LO,GO,NO > *) 0 ; + Teuchos::RCP< Tpetra::Export< LO,GO,NO > > *smartarg1 ; - smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); - arg1 = smartarg1 ? const_cast< Tpetra::Import* >(smartarg1->get()) : NULL; + smartarg1 = static_cast< Teuchos::RCP< Tpetra::Export >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::Export* >(smartarg1->get()) : NULL; { // Make sure no unhandled exceptions exist before performing a new action - SWIG_check_unhandled_exception_impl("Tpetra::Import< LO,GO,NO >::getNumPermuteIDs() const");; + SWIG_check_unhandled_exception_impl("Tpetra::Export< LO,GO,NO >::~Export()");; try { // Attempt the wrapped function call - result = (size_t)((Tpetra::Import< LO,GO,NO > const *)arg1)->getNumPermuteIDs(); + (void)arg1; delete smartarg1; } catch (const std::range_error& e) { // Store a C++ exception - SWIG_exception_impl("Tpetra::Import< LO,GO,NO >::getNumPermuteIDs() const", SWIG_IndexError, e.what(), return 0); + SWIG_exception_impl("Tpetra::Export< LO,GO,NO >::~Export()", SWIG_IndexError, e.what(), return ); } catch (const std::exception& e) { // Store a C++ exception - SWIG_exception_impl("Tpetra::Import< LO,GO,NO >::getNumPermuteIDs() const", SWIG_RuntimeError, e.what(), return 0); + SWIG_exception_impl("Tpetra::Export< LO,GO,NO >::~Export()", SWIG_RuntimeError, e.what(), return ); } catch (...) { - SWIG_exception_impl("Tpetra::Import< LO,GO,NO >::getNumPermuteIDs() const", SWIG_UnknownError, "An unknown exception occurred", return 0); + SWIG_exception_impl("Tpetra::Export< LO,GO,NO >::~Export()", SWIG_UnknownError, "An unknown exception occurred", return ); } } - fresult = static_cast< size_t >(result); - return fresult; + } -SWIGEXPORT size_t _wrap_TpetraImport_getNumRemoteIDs(SwigClassWrapper const *farg1) { - size_t fresult ; - Tpetra::Import< LO,GO,NO > *arg1 = (Tpetra::Import< LO,GO,NO > *) 0 ; - Teuchos::RCP< Tpetra::Import< LO,GO,NO > const > *smartarg1 ; - size_t result; +SWIGEXPORT void _wrap_TpetraExport_setParameterList(SwigClassWrapper const *farg1, SwigClassWrapper const *farg2) { + Tpetra::Export< LO,GO,NO > *arg1 = (Tpetra::Export< LO,GO,NO > *) 0 ; + Teuchos::RCP< Teuchos::ParameterList > *arg2 = 0 ; + Teuchos::RCP< Tpetra::Export< LO,GO,NO > > *smartarg1 ; + Teuchos::RCP< Teuchos::ParameterList > tempnull2 ; - smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); - arg1 = smartarg1 ? const_cast< Tpetra::Import* >(smartarg1->get()) : NULL; + smartarg1 = static_cast< Teuchos::RCP< Tpetra::Export >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::Export* >(smartarg1->get()) : NULL; + arg2 = farg2->cptr ? static_cast< Teuchos::RCP< Teuchos::ParameterList > * >(farg2->cptr) : &tempnull2; { // Make sure no unhandled exceptions exist before performing a new action - SWIG_check_unhandled_exception_impl("Tpetra::Import< LO,GO,NO >::getNumRemoteIDs() const");; + SWIG_check_unhandled_exception_impl("Tpetra::Export< LO,GO,NO >::setParameterList(Teuchos::RCP< Teuchos::ParameterList > const &)");; try { // Attempt the wrapped function call - result = (size_t)((Tpetra::Import< LO,GO,NO > const *)arg1)->getNumRemoteIDs(); + (arg1)->setParameterList((Teuchos::RCP< Teuchos::ParameterList > const &)*arg2); } catch (const std::range_error& e) { // Store a C++ exception - SWIG_exception_impl("Tpetra::Import< LO,GO,NO >::getNumRemoteIDs() const", SWIG_IndexError, e.what(), return 0); + SWIG_exception_impl("Tpetra::Export< LO,GO,NO >::setParameterList(Teuchos::RCP< Teuchos::ParameterList > const &)", SWIG_IndexError, e.what(), return ); } catch (const std::exception& e) { // Store a C++ exception - SWIG_exception_impl("Tpetra::Import< LO,GO,NO >::getNumRemoteIDs() const", SWIG_RuntimeError, e.what(), return 0); + SWIG_exception_impl("Tpetra::Export< LO,GO,NO >::setParameterList(Teuchos::RCP< Teuchos::ParameterList > const &)", SWIG_RuntimeError, e.what(), return ); } catch (...) { - SWIG_exception_impl("Tpetra::Import< LO,GO,NO >::getNumRemoteIDs() const", SWIG_UnknownError, "An unknown exception occurred", return 0); + SWIG_exception_impl("Tpetra::Export< LO,GO,NO >::setParameterList(Teuchos::RCP< Teuchos::ParameterList > const &)", SWIG_UnknownError, "An unknown exception occurred", return ); } } - fresult = static_cast< size_t >(result); - return fresult; + } -SWIGEXPORT size_t _wrap_TpetraImport_getNumExportIDs(SwigClassWrapper const *farg1) { +SWIGEXPORT size_t _wrap_TpetraExport_getNumSameIDs(SwigClassWrapper const *farg1) { size_t fresult ; - Tpetra::Import< LO,GO,NO > *arg1 = (Tpetra::Import< LO,GO,NO > *) 0 ; - Teuchos::RCP< Tpetra::Import< LO,GO,NO > const > *smartarg1 ; + Tpetra::Export< LO,GO,NO > *arg1 = (Tpetra::Export< LO,GO,NO > *) 0 ; + Teuchos::RCP< Tpetra::Export< LO,GO,NO > const > *smartarg1 ; size_t result; - smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); - arg1 = smartarg1 ? const_cast< Tpetra::Import* >(smartarg1->get()) : NULL; + smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::Export* >(smartarg1->get()) : NULL; { // Make sure no unhandled exceptions exist before performing a new action - SWIG_check_unhandled_exception_impl("Tpetra::Import< LO,GO,NO >::getNumExportIDs() const");; + SWIG_check_unhandled_exception_impl("Tpetra::Export< LO,GO,NO >::getNumSameIDs() const");; try { // Attempt the wrapped function call - result = (size_t)((Tpetra::Import< LO,GO,NO > const *)arg1)->getNumExportIDs(); + result = (size_t)((Tpetra::Export< LO,GO,NO > const *)arg1)->getNumSameIDs(); } catch (const std::range_error& e) { // Store a C++ exception - SWIG_exception_impl("Tpetra::Import< LO,GO,NO >::getNumExportIDs() const", SWIG_IndexError, e.what(), return 0); + SWIG_exception_impl("Tpetra::Export< LO,GO,NO >::getNumSameIDs() const", SWIG_IndexError, e.what(), return 0); } catch (const std::exception& e) { // Store a C++ exception - SWIG_exception_impl("Tpetra::Import< LO,GO,NO >::getNumExportIDs() const", SWIG_RuntimeError, e.what(), return 0); + SWIG_exception_impl("Tpetra::Export< LO,GO,NO >::getNumSameIDs() const", SWIG_RuntimeError, e.what(), return 0); } catch (...) { - SWIG_exception_impl("Tpetra::Import< LO,GO,NO >::getNumExportIDs() const", SWIG_UnknownError, "An unknown exception occurred", return 0); + SWIG_exception_impl("Tpetra::Export< LO,GO,NO >::getNumSameIDs() const", SWIG_UnknownError, "An unknown exception occurred", return 0); } } fresult = static_cast< size_t >(result); @@ -3259,237 +3247,226 @@ SWIGEXPORT size_t _wrap_TpetraImport_getNumExportIDs(SwigClassWrapper const *far } -SWIGEXPORT SwigClassWrapper _wrap_TpetraImport_getSourceMap(SwigClassWrapper const *farg1) { - SwigClassWrapper fresult ; - Tpetra::Import< LO,GO,NO > *arg1 = (Tpetra::Import< LO,GO,NO > *) 0 ; - Teuchos::RCP< Tpetra::Import< LO,GO,NO > const > *smartarg1 ; - Teuchos::RCP< Tpetra::Import< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > result; +SWIGEXPORT size_t _wrap_TpetraExport_getNumPermuteIDs(SwigClassWrapper const *farg1) { + size_t fresult ; + Tpetra::Export< LO,GO,NO > *arg1 = (Tpetra::Export< LO,GO,NO > *) 0 ; + Teuchos::RCP< Tpetra::Export< LO,GO,NO > const > *smartarg1 ; + size_t result; - smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); - arg1 = smartarg1 ? const_cast< Tpetra::Import* >(smartarg1->get()) : NULL; + smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::Export* >(smartarg1->get()) : NULL; { // Make sure no unhandled exceptions exist before performing a new action - SWIG_check_unhandled_exception_impl("Tpetra::Import< LO,GO,NO >::getSourceMap() const");; + SWIG_check_unhandled_exception_impl("Tpetra::Export< LO,GO,NO >::getNumPermuteIDs() const");; try { // Attempt the wrapped function call - result = ((Tpetra::Import< LO,GO,NO > const *)arg1)->getSourceMap(); + result = (size_t)((Tpetra::Export< LO,GO,NO > const *)arg1)->getNumPermuteIDs(); } catch (const std::range_error& e) { // Store a C++ exception - SWIG_exception_impl("Tpetra::Import< LO,GO,NO >::getSourceMap() const", SWIG_IndexError, e.what(), return SwigClassWrapper_uninitialized()); + SWIG_exception_impl("Tpetra::Export< LO,GO,NO >::getNumPermuteIDs() const", SWIG_IndexError, e.what(), return 0); } catch (const std::exception& e) { // Store a C++ exception - SWIG_exception_impl("Tpetra::Import< LO,GO,NO >::getSourceMap() const", SWIG_RuntimeError, e.what(), return SwigClassWrapper_uninitialized()); + SWIG_exception_impl("Tpetra::Export< LO,GO,NO >::getNumPermuteIDs() const", SWIG_RuntimeError, e.what(), return 0); } catch (...) { - SWIG_exception_impl("Tpetra::Import< LO,GO,NO >::getSourceMap() const", SWIG_UnknownError, "An unknown exception occurred", return SwigClassWrapper_uninitialized()); + SWIG_exception_impl("Tpetra::Export< LO,GO,NO >::getNumPermuteIDs() const", SWIG_UnknownError, "An unknown exception occurred", return 0); } } - fresult.cptr = (new Teuchos::RCP >(static_cast< const Teuchos::RCP >& >(result))); - fresult.mem = SWIG_MOVE; + fresult = static_cast< size_t >(result); return fresult; } -SWIGEXPORT SwigClassWrapper _wrap_TpetraImport_getTargetMap(SwigClassWrapper const *farg1) { - SwigClassWrapper fresult ; - Tpetra::Import< LO,GO,NO > *arg1 = (Tpetra::Import< LO,GO,NO > *) 0 ; - Teuchos::RCP< Tpetra::Import< LO,GO,NO > const > *smartarg1 ; - Teuchos::RCP< Tpetra::Import< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > result; +SWIGEXPORT size_t _wrap_TpetraExport_getNumRemoteIDs(SwigClassWrapper const *farg1) { + size_t fresult ; + Tpetra::Export< LO,GO,NO > *arg1 = (Tpetra::Export< LO,GO,NO > *) 0 ; + Teuchos::RCP< Tpetra::Export< LO,GO,NO > const > *smartarg1 ; + size_t result; - smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); - arg1 = smartarg1 ? const_cast< Tpetra::Import* >(smartarg1->get()) : NULL; + smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::Export* >(smartarg1->get()) : NULL; { // Make sure no unhandled exceptions exist before performing a new action - SWIG_check_unhandled_exception_impl("Tpetra::Import< LO,GO,NO >::getTargetMap() const");; + SWIG_check_unhandled_exception_impl("Tpetra::Export< LO,GO,NO >::getNumRemoteIDs() const");; try { // Attempt the wrapped function call - result = ((Tpetra::Import< LO,GO,NO > const *)arg1)->getTargetMap(); + result = (size_t)((Tpetra::Export< LO,GO,NO > const *)arg1)->getNumRemoteIDs(); } catch (const std::range_error& e) { // Store a C++ exception - SWIG_exception_impl("Tpetra::Import< LO,GO,NO >::getTargetMap() const", SWIG_IndexError, e.what(), return SwigClassWrapper_uninitialized()); + SWIG_exception_impl("Tpetra::Export< LO,GO,NO >::getNumRemoteIDs() const", SWIG_IndexError, e.what(), return 0); } catch (const std::exception& e) { // Store a C++ exception - SWIG_exception_impl("Tpetra::Import< LO,GO,NO >::getTargetMap() const", SWIG_RuntimeError, e.what(), return SwigClassWrapper_uninitialized()); + SWIG_exception_impl("Tpetra::Export< LO,GO,NO >::getNumRemoteIDs() const", SWIG_RuntimeError, e.what(), return 0); } catch (...) { - SWIG_exception_impl("Tpetra::Import< LO,GO,NO >::getTargetMap() const", SWIG_UnknownError, "An unknown exception occurred", return SwigClassWrapper_uninitialized()); + SWIG_exception_impl("Tpetra::Export< LO,GO,NO >::getNumRemoteIDs() const", SWIG_UnknownError, "An unknown exception occurred", return 0); } } - fresult.cptr = (new Teuchos::RCP >(static_cast< const Teuchos::RCP >& >(result))); - fresult.mem = SWIG_MOVE; + fresult = static_cast< size_t >(result); return fresult; } -SWIGEXPORT int _wrap_TpetraImport_isLocallyComplete(SwigClassWrapper const *farg1) { - int fresult ; - Tpetra::Import< LO,GO,NO > *arg1 = (Tpetra::Import< LO,GO,NO > *) 0 ; - Teuchos::RCP< Tpetra::Import< LO,GO,NO > const > *smartarg1 ; - bool result; +SWIGEXPORT size_t _wrap_TpetraExport_getNumExportIDs(SwigClassWrapper const *farg1) { + size_t fresult ; + Tpetra::Export< LO,GO,NO > *arg1 = (Tpetra::Export< LO,GO,NO > *) 0 ; + Teuchos::RCP< Tpetra::Export< LO,GO,NO > const > *smartarg1 ; + size_t result; - smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); - arg1 = smartarg1 ? const_cast< Tpetra::Import* >(smartarg1->get()) : NULL; + smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::Export* >(smartarg1->get()) : NULL; { // Make sure no unhandled exceptions exist before performing a new action - SWIG_check_unhandled_exception_impl("Tpetra::Import< LO,GO,NO >::isLocallyComplete() const");; + SWIG_check_unhandled_exception_impl("Tpetra::Export< LO,GO,NO >::getNumExportIDs() const");; try { // Attempt the wrapped function call - result = (bool)((Tpetra::Import< LO,GO,NO > const *)arg1)->isLocallyComplete(); + result = (size_t)((Tpetra::Export< LO,GO,NO > const *)arg1)->getNumExportIDs(); } catch (const std::range_error& e) { // Store a C++ exception - SWIG_exception_impl("Tpetra::Import< LO,GO,NO >::isLocallyComplete() const", SWIG_IndexError, e.what(), return 0); + SWIG_exception_impl("Tpetra::Export< LO,GO,NO >::getNumExportIDs() const", SWIG_IndexError, e.what(), return 0); } catch (const std::exception& e) { // Store a C++ exception - SWIG_exception_impl("Tpetra::Import< LO,GO,NO >::isLocallyComplete() const", SWIG_RuntimeError, e.what(), return 0); + SWIG_exception_impl("Tpetra::Export< LO,GO,NO >::getNumExportIDs() const", SWIG_RuntimeError, e.what(), return 0); } catch (...) { - SWIG_exception_impl("Tpetra::Import< LO,GO,NO >::isLocallyComplete() const", SWIG_UnknownError, "An unknown exception occurred", return 0); + SWIG_exception_impl("Tpetra::Export< LO,GO,NO >::getNumExportIDs() const", SWIG_UnknownError, "An unknown exception occurred", return 0); } } - fresult = (result ? 1 : 0); + fresult = static_cast< size_t >(result); return fresult; } -SWIGEXPORT SwigClassWrapper _wrap_TpetraImport_setUnion__SWIG_0(SwigClassWrapper const *farg1, SwigClassWrapper const *farg2) { +SWIGEXPORT SwigClassWrapper _wrap_TpetraExport_getSourceMap(SwigClassWrapper const *farg1) { SwigClassWrapper fresult ; - Tpetra::Import< LO,GO,NO > *arg1 = (Tpetra::Import< LO,GO,NO > *) 0 ; - Tpetra::Import< int,long long,Kokkos::Compat::KokkosSerialWrapperNode > *arg2 = 0 ; - Teuchos::RCP< Tpetra::Import< LO,GO,NO > const > *smartarg1 ; - Teuchos::RCP< Tpetra::Import< LO,GO,NO > const > *smartarg2 ; - Teuchos::RCP< Tpetra::Import< int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const > result; + Tpetra::Export< LO,GO,NO > *arg1 = (Tpetra::Export< LO,GO,NO > *) 0 ; + Teuchos::RCP< Tpetra::Export< LO,GO,NO > const > *smartarg1 ; + Teuchos::RCP< Tpetra::Export< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > result; - smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); - arg1 = smartarg1 ? const_cast< Tpetra::Import* >(smartarg1->get()) : NULL; - SWIG_check_sp_nonnull(farg2, "Tpetra::Import< int,long long,Kokkos::Compat::KokkosSerialWrapperNode > *", "TpetraImport", "Tpetra::Import< LO,GO,NO >::setUnion(Tpetra::Import< int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &) const", return SwigClassWrapper_uninitialized()) - smartarg2 = static_cast< Teuchos::RCP >* >(farg2->cptr); - arg2 = const_cast< Tpetra::Import* >(smartarg2->get()); + smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::Export* >(smartarg1->get()) : NULL; { // Make sure no unhandled exceptions exist before performing a new action - SWIG_check_unhandled_exception_impl("Tpetra::Import< LO,GO,NO >::setUnion(Tpetra::Import< int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &) const");; + SWIG_check_unhandled_exception_impl("Tpetra::Export< LO,GO,NO >::getSourceMap() const");; try { // Attempt the wrapped function call - result = ((Tpetra::Import< LO,GO,NO > const *)arg1)->setUnion((Tpetra::Import< int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &)*arg2); + result = ((Tpetra::Export< LO,GO,NO > const *)arg1)->getSourceMap(); } catch (const std::range_error& e) { // Store a C++ exception - SWIG_exception_impl("Tpetra::Import< LO,GO,NO >::setUnion(Tpetra::Import< int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &) const", SWIG_IndexError, e.what(), return SwigClassWrapper_uninitialized()); + SWIG_exception_impl("Tpetra::Export< LO,GO,NO >::getSourceMap() const", SWIG_IndexError, e.what(), return SwigClassWrapper_uninitialized()); } catch (const std::exception& e) { // Store a C++ exception - SWIG_exception_impl("Tpetra::Import< LO,GO,NO >::setUnion(Tpetra::Import< int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &) const", SWIG_RuntimeError, e.what(), return SwigClassWrapper_uninitialized()); + SWIG_exception_impl("Tpetra::Export< LO,GO,NO >::getSourceMap() const", SWIG_RuntimeError, e.what(), return SwigClassWrapper_uninitialized()); } catch (...) { - SWIG_exception_impl("Tpetra::Import< LO,GO,NO >::setUnion(Tpetra::Import< int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &) const", SWIG_UnknownError, "An unknown exception occurred", return SwigClassWrapper_uninitialized()); + SWIG_exception_impl("Tpetra::Export< LO,GO,NO >::getSourceMap() const", SWIG_UnknownError, "An unknown exception occurred", return SwigClassWrapper_uninitialized()); } } - fresult.cptr = (new Teuchos::RCP >(static_cast< const Teuchos::RCP >& >(result))); + fresult.cptr = (new Teuchos::RCP >(static_cast< const Teuchos::RCP >& >(result))); fresult.mem = SWIG_MOVE; return fresult; } -SWIGEXPORT SwigClassWrapper _wrap_TpetraImport_setUnion__SWIG_1(SwigClassWrapper const *farg1) { +SWIGEXPORT SwigClassWrapper _wrap_TpetraExport_getTargetMap(SwigClassWrapper const *farg1) { SwigClassWrapper fresult ; - Tpetra::Import< LO,GO,NO > *arg1 = (Tpetra::Import< LO,GO,NO > *) 0 ; - Teuchos::RCP< Tpetra::Import< LO,GO,NO > const > *smartarg1 ; - Teuchos::RCP< Tpetra::Import< int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const > result; + Tpetra::Export< LO,GO,NO > *arg1 = (Tpetra::Export< LO,GO,NO > *) 0 ; + Teuchos::RCP< Tpetra::Export< LO,GO,NO > const > *smartarg1 ; + Teuchos::RCP< Tpetra::Export< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > result; - smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); - arg1 = smartarg1 ? const_cast< Tpetra::Import* >(smartarg1->get()) : NULL; + smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::Export* >(smartarg1->get()) : NULL; { // Make sure no unhandled exceptions exist before performing a new action - SWIG_check_unhandled_exception_impl("Tpetra::Import< LO,GO,NO >::setUnion() const");; + SWIG_check_unhandled_exception_impl("Tpetra::Export< LO,GO,NO >::getTargetMap() const");; try { // Attempt the wrapped function call - result = ((Tpetra::Import< LO,GO,NO > const *)arg1)->setUnion(); + result = ((Tpetra::Export< LO,GO,NO > const *)arg1)->getTargetMap(); } catch (const std::range_error& e) { // Store a C++ exception - SWIG_exception_impl("Tpetra::Import< LO,GO,NO >::setUnion() const", SWIG_IndexError, e.what(), return SwigClassWrapper_uninitialized()); + SWIG_exception_impl("Tpetra::Export< LO,GO,NO >::getTargetMap() const", SWIG_IndexError, e.what(), return SwigClassWrapper_uninitialized()); } catch (const std::exception& e) { // Store a C++ exception - SWIG_exception_impl("Tpetra::Import< LO,GO,NO >::setUnion() const", SWIG_RuntimeError, e.what(), return SwigClassWrapper_uninitialized()); + SWIG_exception_impl("Tpetra::Export< LO,GO,NO >::getTargetMap() const", SWIG_RuntimeError, e.what(), return SwigClassWrapper_uninitialized()); } catch (...) { - SWIG_exception_impl("Tpetra::Import< LO,GO,NO >::setUnion() const", SWIG_UnknownError, "An unknown exception occurred", return SwigClassWrapper_uninitialized()); + SWIG_exception_impl("Tpetra::Export< LO,GO,NO >::getTargetMap() const", SWIG_UnknownError, "An unknown exception occurred", return SwigClassWrapper_uninitialized()); } } - fresult.cptr = (new Teuchos::RCP >(static_cast< const Teuchos::RCP >& >(result))); + fresult.cptr = (new Teuchos::RCP >(static_cast< const Teuchos::RCP >& >(result))); fresult.mem = SWIG_MOVE; return fresult; } -SWIGEXPORT SwigClassWrapper _wrap_TpetraImport_createRemoteOnlyImport(SwigClassWrapper const *farg1, SwigClassWrapper const *farg2) { - SwigClassWrapper fresult ; - Tpetra::Import< LO,GO,NO > *arg1 = (Tpetra::Import< LO,GO,NO > *) 0 ; - Teuchos::RCP< Tpetra::Import< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > *arg2 = 0 ; - Teuchos::RCP< Tpetra::Import< LO,GO,NO > const > *smartarg1 ; - Teuchos::RCP< Tpetra::Import< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > tempnull2 ; - Teuchos::RCP< Tpetra::Import< int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const > result; +SWIGEXPORT int _wrap_TpetraExport_isLocallyComplete(SwigClassWrapper const *farg1) { + int fresult ; + Tpetra::Export< LO,GO,NO > *arg1 = (Tpetra::Export< LO,GO,NO > *) 0 ; + Teuchos::RCP< Tpetra::Export< LO,GO,NO > const > *smartarg1 ; + bool result; - smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); - arg1 = smartarg1 ? const_cast< Tpetra::Import* >(smartarg1->get()) : NULL; - arg2 = farg2->cptr ? static_cast< Teuchos::RCP< Tpetra::Import< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg2->cptr) : &tempnull2; + smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::Export* >(smartarg1->get()) : NULL; { // Make sure no unhandled exceptions exist before performing a new action - SWIG_check_unhandled_exception_impl("Tpetra::Import< LO,GO,NO >::createRemoteOnlyImport(Teuchos::RCP< Tpetra::Import< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &) const");; + SWIG_check_unhandled_exception_impl("Tpetra::Export< LO,GO,NO >::isLocallyComplete() const");; try { // Attempt the wrapped function call - result = ((Tpetra::Import< LO,GO,NO > const *)arg1)->createRemoteOnlyImport((Teuchos::RCP< Tpetra::Import< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &)*arg2); + result = (bool)((Tpetra::Export< LO,GO,NO > const *)arg1)->isLocallyComplete(); } catch (const std::range_error& e) { // Store a C++ exception - SWIG_exception_impl("Tpetra::Import< LO,GO,NO >::createRemoteOnlyImport(Teuchos::RCP< Tpetra::Import< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &) const", SWIG_IndexError, e.what(), return SwigClassWrapper_uninitialized()); + SWIG_exception_impl("Tpetra::Export< LO,GO,NO >::isLocallyComplete() const", SWIG_IndexError, e.what(), return 0); } catch (const std::exception& e) { // Store a C++ exception - SWIG_exception_impl("Tpetra::Import< LO,GO,NO >::createRemoteOnlyImport(Teuchos::RCP< Tpetra::Import< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &) const", SWIG_RuntimeError, e.what(), return SwigClassWrapper_uninitialized()); + SWIG_exception_impl("Tpetra::Export< LO,GO,NO >::isLocallyComplete() const", SWIG_RuntimeError, e.what(), return 0); } catch (...) { - SWIG_exception_impl("Tpetra::Import< LO,GO,NO >::createRemoteOnlyImport(Teuchos::RCP< Tpetra::Import< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &) const", SWIG_UnknownError, "An unknown exception occurred", return SwigClassWrapper_uninitialized()); + SWIG_exception_impl("Tpetra::Export< LO,GO,NO >::isLocallyComplete() const", SWIG_UnknownError, "An unknown exception occurred", return 0); } } - fresult.cptr = (new Teuchos::RCP >(static_cast< const Teuchos::RCP >& >(result))); - fresult.mem = SWIG_MOVE; + fresult = (result ? 1 : 0); return fresult; } -SWIGEXPORT void _wrap_assign_TpetraImport(SwigClassWrapper * self, SwigClassWrapper const * other) { - typedef Teuchos::RCP< Tpetra::Import > swig_lhs_classtype; +SWIGEXPORT void _wrap_assign_TpetraExport(SwigClassWrapper * self, SwigClassWrapper const * other) { + typedef Teuchos::RCP< Tpetra::Export > swig_lhs_classtype; SWIG_assign(swig_lhs_classtype, self, swig_lhs_classtype, const_cast(other), 0 | swig::IS_DESTR | swig::IS_COPY_CONSTR | swig::IS_COPY_ASSIGN); @@ -10041,45 +10018,6 @@ SWIGEXPORT SwigClassWrapper _wrap_new_TpetraCrsGraph__SWIG_13(SwigClassWrapper c } -SWIGEXPORT void _wrap_TpetraCrsGraph_setAllIndices(SwigClassWrapper const *farg1, SwigArrayWrapper *farg2, SwigArrayWrapper *farg3, SwigArrayWrapper *farg4) { - Tpetra::CrsGraph< LO,GO,NO > *arg1 = (Tpetra::CrsGraph< LO,GO,NO > *) 0 ; - Teuchos::ArrayView< std::size_t > arg2 ; - Teuchos::ArrayView< LO > arg3 ; - Teuchos::ArrayView< SC > arg4 ; - Teuchos::RCP< Tpetra::CrsGraph< LO,GO,NO > > *smartarg1 ; - - smartarg1 = static_cast< Teuchos::RCP< Tpetra::CrsGraph >* >(farg1->cptr); - arg1 = smartarg1 ? const_cast< Tpetra::CrsGraph* >(smartarg1->get()) : NULL; - arg2 = Teuchos::ArrayView(static_cast(farg2->data), farg2->size); - arg3 = Teuchos::ArrayView(static_cast(farg3->data), farg3->size); - arg4 = Teuchos::ArrayView(static_cast(farg4->data), farg4->size); - { - // Make sure no unhandled exceptions exist before performing a new action - SWIG_check_unhandled_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::setAllIndices(Teuchos::ArrayView< std::size_t >,Teuchos::ArrayView< LO >,Teuchos::ArrayView< SC >)");; - try - { - // Attempt the wrapped function call - Tpetra_CrsGraph_Sl_LO_Sc_GO_Sc_NO_Sg__setAllIndices(arg1,arg2,arg3,arg4); - } - catch (const std::range_error& e) - { - // Store a C++ exception - SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::setAllIndices(Teuchos::ArrayView< std::size_t >,Teuchos::ArrayView< LO >,Teuchos::ArrayView< SC >)", SWIG_IndexError, e.what(), return ); - } - catch (const std::exception& e) - { - // Store a C++ exception - SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::setAllIndices(Teuchos::ArrayView< std::size_t >,Teuchos::ArrayView< LO >,Teuchos::ArrayView< SC >)", SWIG_RuntimeError, e.what(), return ); - } - catch (...) - { - SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::setAllIndices(Teuchos::ArrayView< std::size_t >,Teuchos::ArrayView< LO >,Teuchos::ArrayView< SC >)", SWIG_UnknownError, "An unknown exception occurred", return ); - } - } - -} - - SWIGEXPORT void _wrap_TpetraCrsGraph_getNodeRowPtrs(SwigClassWrapper const *farg1, SwigArrayWrapper *farg2) { Tpetra::CrsGraph< LO,GO,NO > *arg1 = (Tpetra::CrsGraph< LO,GO,NO > *) 0 ; Teuchos::ArrayView< std::size_t > arg2 ; @@ -14336,186 +14274,6 @@ SWIGEXPORT void _wrap_TpetraCrsMatrix_getAllValues(SwigClassWrapper const *farg1 } -SWIGEXPORT void _wrap_TpetraCrsMatrix_doImport__SWIG_0(SwigClassWrapper const *farg1, SwigClassWrapper const *farg2, SwigClassWrapper const *farg3, int const *farg4) { - Tpetra::CrsMatrix< SC,LO,GO,NO > *arg1 = (Tpetra::CrsMatrix< SC,LO,GO,NO > *) 0 ; - Tpetra::CrsMatrix< SC,LO,GO,NO > *arg2 = 0 ; - Tpetra::Import< LO,GO,NO > *arg3 = 0 ; - Tpetra::CombineMode arg4 ; - Teuchos::RCP< Tpetra::CrsMatrix< SC,LO,GO,NO > > *smartarg1 ; - Teuchos::RCP< Tpetra::CrsMatrix< SC,LO,GO,NO > const > *smartarg2 ; - Teuchos::RCP< Tpetra::Import< LO,GO,NO > const > *smartarg3 ; - - smartarg1 = static_cast< Teuchos::RCP< Tpetra::CrsMatrix >* >(farg1->cptr); - arg1 = smartarg1 ? const_cast< Tpetra::CrsMatrix* >(smartarg1->get()) : NULL; - SWIG_check_sp_nonnull(farg2, "Tpetra::CrsMatrix< SC,LO,GO,NO > *", "TpetraCrsMatrix", "Tpetra::CrsMatrix< SC,LO,GO,NO >::doImport(Tpetra::CrsMatrix< SC,LO,GO,NO > const &,Tpetra::Import< LO,GO,NO > const &,Tpetra::CombineMode)", return ) - smartarg2 = static_cast< Teuchos::RCP >* >(farg2->cptr); - arg2 = const_cast< Tpetra::CrsMatrix* >(smartarg2->get()); - SWIG_check_sp_nonnull(farg3, "Tpetra::Import< LO,GO,NO > *", "TpetraImport", "Tpetra::CrsMatrix< SC,LO,GO,NO >::doImport(Tpetra::CrsMatrix< SC,LO,GO,NO > const &,Tpetra::Import< LO,GO,NO > const &,Tpetra::CombineMode)", return ) - smartarg3 = static_cast< Teuchos::RCP >* >(farg3->cptr); - arg3 = const_cast< Tpetra::Import* >(smartarg3->get()); - arg4 = static_cast< Tpetra::CombineMode >(*farg4); - { - // Make sure no unhandled exceptions exist before performing a new action - SWIG_check_unhandled_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::doImport(Tpetra::CrsMatrix< SC,LO,GO,NO > const &,Tpetra::Import< LO,GO,NO > const &,Tpetra::CombineMode)");; - try - { - // Attempt the wrapped function call - Tpetra_CrsMatrix_Sl_SC_Sc_LO_Sc_GO_Sc_NO_Sg__doImport__SWIG_0(arg1,(Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &)*arg2,(Tpetra::Import< int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &)*arg3,arg4); - } - catch (const std::range_error& e) - { - // Store a C++ exception - SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::doImport(Tpetra::CrsMatrix< SC,LO,GO,NO > const &,Tpetra::Import< LO,GO,NO > const &,Tpetra::CombineMode)", SWIG_IndexError, e.what(), return ); - } - catch (const std::exception& e) - { - // Store a C++ exception - SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::doImport(Tpetra::CrsMatrix< SC,LO,GO,NO > const &,Tpetra::Import< LO,GO,NO > const &,Tpetra::CombineMode)", SWIG_RuntimeError, e.what(), return ); - } - catch (...) - { - SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::doImport(Tpetra::CrsMatrix< SC,LO,GO,NO > const &,Tpetra::Import< LO,GO,NO > const &,Tpetra::CombineMode)", SWIG_UnknownError, "An unknown exception occurred", return ); - } - } - -} - - -SWIGEXPORT void _wrap_TpetraCrsMatrix_doImport__SWIG_1(SwigClassWrapper const *farg1, SwigClassWrapper const *farg2, SwigClassWrapper const *farg3, int const *farg4) { - Tpetra::CrsMatrix< SC,LO,GO,NO > *arg1 = (Tpetra::CrsMatrix< SC,LO,GO,NO > *) 0 ; - Tpetra::CrsMatrix< SC,LO,GO,NO > *arg2 = 0 ; - Tpetra::Export< LO,GO,NO > *arg3 = 0 ; - Tpetra::CombineMode arg4 ; - Teuchos::RCP< Tpetra::CrsMatrix< SC,LO,GO,NO > > *smartarg1 ; - Teuchos::RCP< Tpetra::CrsMatrix< SC,LO,GO,NO > const > *smartarg2 ; - Teuchos::RCP< Tpetra::Export< LO,GO,NO > const > *smartarg3 ; - - smartarg1 = static_cast< Teuchos::RCP< Tpetra::CrsMatrix >* >(farg1->cptr); - arg1 = smartarg1 ? const_cast< Tpetra::CrsMatrix* >(smartarg1->get()) : NULL; - SWIG_check_sp_nonnull(farg2, "Tpetra::CrsMatrix< SC,LO,GO,NO > *", "TpetraCrsMatrix", "Tpetra::CrsMatrix< SC,LO,GO,NO >::doImport(Tpetra::CrsMatrix< SC,LO,GO,NO > const &,Tpetra::Export< LO,GO,NO > const &,Tpetra::CombineMode)", return ) - smartarg2 = static_cast< Teuchos::RCP >* >(farg2->cptr); - arg2 = const_cast< Tpetra::CrsMatrix* >(smartarg2->get()); - SWIG_check_sp_nonnull(farg3, "Tpetra::Export< LO,GO,NO > *", "TpetraExport", "Tpetra::CrsMatrix< SC,LO,GO,NO >::doImport(Tpetra::CrsMatrix< SC,LO,GO,NO > const &,Tpetra::Export< LO,GO,NO > const &,Tpetra::CombineMode)", return ) - smartarg3 = static_cast< Teuchos::RCP >* >(farg3->cptr); - arg3 = const_cast< Tpetra::Export* >(smartarg3->get()); - arg4 = static_cast< Tpetra::CombineMode >(*farg4); - { - // Make sure no unhandled exceptions exist before performing a new action - SWIG_check_unhandled_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::doImport(Tpetra::CrsMatrix< SC,LO,GO,NO > const &,Tpetra::Export< LO,GO,NO > const &,Tpetra::CombineMode)");; - try - { - // Attempt the wrapped function call - Tpetra_CrsMatrix_Sl_SC_Sc_LO_Sc_GO_Sc_NO_Sg__doImport__SWIG_1(arg1,(Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &)*arg2,(Tpetra::Export< int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &)*arg3,arg4); - } - catch (const std::range_error& e) - { - // Store a C++ exception - SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::doImport(Tpetra::CrsMatrix< SC,LO,GO,NO > const &,Tpetra::Export< LO,GO,NO > const &,Tpetra::CombineMode)", SWIG_IndexError, e.what(), return ); - } - catch (const std::exception& e) - { - // Store a C++ exception - SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::doImport(Tpetra::CrsMatrix< SC,LO,GO,NO > const &,Tpetra::Export< LO,GO,NO > const &,Tpetra::CombineMode)", SWIG_RuntimeError, e.what(), return ); - } - catch (...) - { - SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::doImport(Tpetra::CrsMatrix< SC,LO,GO,NO > const &,Tpetra::Export< LO,GO,NO > const &,Tpetra::CombineMode)", SWIG_UnknownError, "An unknown exception occurred", return ); - } - } - -} - - -SWIGEXPORT void _wrap_TpetraCrsMatrix_doExport__SWIG_0(SwigClassWrapper const *farg1, SwigClassWrapper const *farg2, SwigClassWrapper const *farg3, int const *farg4) { - Tpetra::CrsMatrix< SC,LO,GO,NO > *arg1 = (Tpetra::CrsMatrix< SC,LO,GO,NO > *) 0 ; - Tpetra::CrsMatrix< SC,LO,GO,NO > *arg2 = 0 ; - Tpetra::Export< LO,GO,NO > *arg3 = 0 ; - Tpetra::CombineMode arg4 ; - Teuchos::RCP< Tpetra::CrsMatrix< SC,LO,GO,NO > > *smartarg1 ; - Teuchos::RCP< Tpetra::CrsMatrix< SC,LO,GO,NO > const > *smartarg2 ; - Teuchos::RCP< Tpetra::Export< LO,GO,NO > const > *smartarg3 ; - - smartarg1 = static_cast< Teuchos::RCP< Tpetra::CrsMatrix >* >(farg1->cptr); - arg1 = smartarg1 ? const_cast< Tpetra::CrsMatrix* >(smartarg1->get()) : NULL; - SWIG_check_sp_nonnull(farg2, "Tpetra::CrsMatrix< SC,LO,GO,NO > *", "TpetraCrsMatrix", "Tpetra::CrsMatrix< SC,LO,GO,NO >::doExport(Tpetra::CrsMatrix< SC,LO,GO,NO > const &,Tpetra::Export< LO,GO,NO > const &,Tpetra::CombineMode)", return ) - smartarg2 = static_cast< Teuchos::RCP >* >(farg2->cptr); - arg2 = const_cast< Tpetra::CrsMatrix* >(smartarg2->get()); - SWIG_check_sp_nonnull(farg3, "Tpetra::Export< LO,GO,NO > *", "TpetraExport", "Tpetra::CrsMatrix< SC,LO,GO,NO >::doExport(Tpetra::CrsMatrix< SC,LO,GO,NO > const &,Tpetra::Export< LO,GO,NO > const &,Tpetra::CombineMode)", return ) - smartarg3 = static_cast< Teuchos::RCP >* >(farg3->cptr); - arg3 = const_cast< Tpetra::Export* >(smartarg3->get()); - arg4 = static_cast< Tpetra::CombineMode >(*farg4); - { - // Make sure no unhandled exceptions exist before performing a new action - SWIG_check_unhandled_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::doExport(Tpetra::CrsMatrix< SC,LO,GO,NO > const &,Tpetra::Export< LO,GO,NO > const &,Tpetra::CombineMode)");; - try - { - // Attempt the wrapped function call - Tpetra_CrsMatrix_Sl_SC_Sc_LO_Sc_GO_Sc_NO_Sg__doExport__SWIG_0(arg1,(Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &)*arg2,(Tpetra::Export< int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &)*arg3,arg4); - } - catch (const std::range_error& e) - { - // Store a C++ exception - SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::doExport(Tpetra::CrsMatrix< SC,LO,GO,NO > const &,Tpetra::Export< LO,GO,NO > const &,Tpetra::CombineMode)", SWIG_IndexError, e.what(), return ); - } - catch (const std::exception& e) - { - // Store a C++ exception - SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::doExport(Tpetra::CrsMatrix< SC,LO,GO,NO > const &,Tpetra::Export< LO,GO,NO > const &,Tpetra::CombineMode)", SWIG_RuntimeError, e.what(), return ); - } - catch (...) - { - SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::doExport(Tpetra::CrsMatrix< SC,LO,GO,NO > const &,Tpetra::Export< LO,GO,NO > const &,Tpetra::CombineMode)", SWIG_UnknownError, "An unknown exception occurred", return ); - } - } - -} - - -SWIGEXPORT void _wrap_TpetraCrsMatrix_doExport__SWIG_1(SwigClassWrapper const *farg1, SwigClassWrapper const *farg2, SwigClassWrapper const *farg3, int const *farg4) { - Tpetra::CrsMatrix< SC,LO,GO,NO > *arg1 = (Tpetra::CrsMatrix< SC,LO,GO,NO > *) 0 ; - Tpetra::CrsMatrix< SC,LO,GO,NO > *arg2 = 0 ; - Tpetra::Import< LO,GO,NO > *arg3 = 0 ; - Tpetra::CombineMode arg4 ; - Teuchos::RCP< Tpetra::CrsMatrix< SC,LO,GO,NO > > *smartarg1 ; - Teuchos::RCP< Tpetra::CrsMatrix< SC,LO,GO,NO > const > *smartarg2 ; - Teuchos::RCP< Tpetra::Import< LO,GO,NO > const > *smartarg3 ; - - smartarg1 = static_cast< Teuchos::RCP< Tpetra::CrsMatrix >* >(farg1->cptr); - arg1 = smartarg1 ? const_cast< Tpetra::CrsMatrix* >(smartarg1->get()) : NULL; - SWIG_check_sp_nonnull(farg2, "Tpetra::CrsMatrix< SC,LO,GO,NO > *", "TpetraCrsMatrix", "Tpetra::CrsMatrix< SC,LO,GO,NO >::doExport(Tpetra::CrsMatrix< SC,LO,GO,NO > const &,Tpetra::Import< LO,GO,NO > const &,Tpetra::CombineMode)", return ) - smartarg2 = static_cast< Teuchos::RCP >* >(farg2->cptr); - arg2 = const_cast< Tpetra::CrsMatrix* >(smartarg2->get()); - SWIG_check_sp_nonnull(farg3, "Tpetra::Import< LO,GO,NO > *", "TpetraImport", "Tpetra::CrsMatrix< SC,LO,GO,NO >::doExport(Tpetra::CrsMatrix< SC,LO,GO,NO > const &,Tpetra::Import< LO,GO,NO > const &,Tpetra::CombineMode)", return ) - smartarg3 = static_cast< Teuchos::RCP >* >(farg3->cptr); - arg3 = const_cast< Tpetra::Import* >(smartarg3->get()); - arg4 = static_cast< Tpetra::CombineMode >(*farg4); - { - // Make sure no unhandled exceptions exist before performing a new action - SWIG_check_unhandled_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::doExport(Tpetra::CrsMatrix< SC,LO,GO,NO > const &,Tpetra::Import< LO,GO,NO > const &,Tpetra::CombineMode)");; - try - { - // Attempt the wrapped function call - Tpetra_CrsMatrix_Sl_SC_Sc_LO_Sc_GO_Sc_NO_Sg__doExport__SWIG_1(arg1,(Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &)*arg2,(Tpetra::Import< int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &)*arg3,arg4); - } - catch (const std::range_error& e) - { - // Store a C++ exception - SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::doExport(Tpetra::CrsMatrix< SC,LO,GO,NO > const &,Tpetra::Import< LO,GO,NO > const &,Tpetra::CombineMode)", SWIG_IndexError, e.what(), return ); - } - catch (const std::exception& e) - { - // Store a C++ exception - SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::doExport(Tpetra::CrsMatrix< SC,LO,GO,NO > const &,Tpetra::Import< LO,GO,NO > const &,Tpetra::CombineMode)", SWIG_RuntimeError, e.what(), return ); - } - catch (...) - { - SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::doExport(Tpetra::CrsMatrix< SC,LO,GO,NO > const &,Tpetra::Import< LO,GO,NO > const &,Tpetra::CombineMode)", SWIG_UnknownError, "An unknown exception occurred", return ); - } - } - -} - - SWIGEXPORT void _wrap_assign_TpetraCrsMatrix(SwigClassWrapper * self, SwigClassWrapper const * other) { typedef Teuchos::RCP< Tpetra::CrsMatrix > swig_lhs_classtype; SWIG_assign(swig_lhs_classtype, self, From e7b8129d39287f6805c7eca3d18a39314e68b83b Mon Sep 17 00:00:00 2001 From: Seth R Johnson Date: Mon, 4 Feb 2019 10:44:51 -0500 Subject: [PATCH 20/40] Combine several "ignore" directives --- src/teuchos/src/Teuchos_Traits.i | 15 ++++ src/teuchos/src/forteuchos.i | 26 ++++--- src/tpetra/src/Tpetra_CrsGraph.i | 13 +--- src/tpetra/src/Tpetra_CrsMatrix.i | 3 - src/tpetra/src/Tpetra_DistObject.i | 2 - src/tpetra/src/Tpetra_Import_Export.i | 6 -- src/tpetra/src/Tpetra_InOut.i | 3 +- src/tpetra/src/Tpetra_Map.i | 2 - src/tpetra/src/fortpetra.i | 4 +- src/tpetra/src/swig/fortpetra.F90 | 49 +++++++++++++ src/tpetra/src/swig/fortpetraFORTRAN_wrap.cxx | 72 +++++++++++++++++++ 11 files changed, 160 insertions(+), 35 deletions(-) create mode 100644 src/teuchos/src/Teuchos_Traits.i diff --git a/src/teuchos/src/Teuchos_Traits.i b/src/teuchos/src/Teuchos_Traits.i new file mode 100644 index 00000000..ee57aae9 --- /dev/null +++ b/src/teuchos/src/Teuchos_Traits.i @@ -0,0 +1,15 @@ +/* + * Copyright 2017-2018, UT-Battelle, LLC + * + * SPDX-License-Identifier: BSD-3-Clause + * License-Filename: LICENSE + */ + +// Declare and ignore some traits classes +namespace Teuchos { + template class SerializationTraits; + template class TypeNameTraits; +} +%ignore Teuchos::SerializationTraits; +%ignore Teuchos::TypeNameTraits; + diff --git a/src/teuchos/src/forteuchos.i b/src/teuchos/src/forteuchos.i index 31bd3d99..e067aecf 100644 --- a/src/teuchos/src/forteuchos.i +++ b/src/teuchos/src/forteuchos.i @@ -9,6 +9,13 @@ %include %include +// Convert all std::string references/values to and from Fortran strings +%include + +// ======================================================================= +// Global treatments +// ======================================================================= + // By default, wrap all constants as Fortran literals %fortranconst; @@ -23,21 +30,22 @@ typedef int Teuchos_Ordinal; %typemap(fin) int "$1 = int($input, C_INT)" %typemap(fout) int "$result = int($1)" -// Convert all std::string references/values to and from Fortran strings -%include +// Ignore methods that require non-implemented types or operators +%ignore *::describe; +%ignore *::print(std::ostream& os); +%ignore *::operator=; +%ignore *::operator<<; +%ignore *::operator(); -// Declare and ignore some traits classes -namespace Teuchos { - template class SerializationTraits; - template class TypeNameTraits; -} -%ignore Teuchos::SerializationTraits; -%ignore Teuchos::TypeNameTraits; +// ======================================================================= +// Wrap +// ======================================================================= // Prefix all enums with Teuchos %rename("Teuchos%s",%$isenumitem) ""; %rename("Teuchos%s",%$isenum) ""; +%include "Teuchos_Traits.i" %include "Teuchos_Types.i" %include "Teuchos_Exceptions.i" %include "Teuchos_RCP.i" diff --git a/src/tpetra/src/Tpetra_CrsGraph.i b/src/tpetra/src/Tpetra_CrsGraph.i index aafd5e58..be9ad910 100644 --- a/src/tpetra/src/Tpetra_CrsGraph.i +++ b/src/tpetra/src/Tpetra_CrsGraph.i @@ -18,7 +18,6 @@ // ======================================================================= // Ignore permanently // ======================================================================= -%ignore Tpetra::CrsGraph::getNode; %ignore Tpetra::CrsGraph::checkSizes; %ignore Tpetra::CrsGraph::copyAndPermute; %ignore Tpetra::CrsGraph::packAndPrepare; @@ -56,7 +55,6 @@ const Teuchos::RCP< const map_type > &rangeMap=Teuchos::null, const Teuchos::RCP< Teuchos::ParameterList > ¶ms=Teuchos::null); // needs Kokkos::StaticCrsGraph %ignore Tpetra::CrsGraph::insertLocalIndices(const LocalOrdinal localRow, const LocalOrdinal numEnt, const LocalOrdinal inds[]); // prefer ArrayView variant -%ignore Tpetra::CrsGraph::describe; // needs Teuchos::FancyOStream %ignore Tpetra::CrsGraph::getLocalDiagOffsets (const Kokkos::View< size_t *, device_type, Kokkos::MemoryUnmanaged > &offsets) const; // needs Kokkos::View %ignore Tpetra::CrsGraph::getNumEntriesPerLocalRowUpperBound; // needs Teuchos::ArrayRCP %ignore Tpetra::CrsGraph::getLocalGraph; // needs Kokkos::StaticCrsGraph @@ -64,6 +62,8 @@ // Returns ArrayView by reference %ignore Tpetra::CrsGraph::getGlobalRowView; +// "should never be called by user code" +%ignore Tpetra::CrsGraph::setAllIndices; // ======================================================================= // Fix ±1 issues @@ -108,15 +108,6 @@ return new Tpetra::CrsGraph(rowMap, colMap, Teuchos::arcpFromArray(rowPointersArray), Teuchos::arcpFromArray(columnIndicesArray), params); } - void setAllIndices(Teuchos::ArrayView rowPointers, Teuchos::ArrayView columnIndices, Teuchos::ArrayView val) { - Teuchos::ArrayRCP rowPointersArrayRCP(rowPointers.size()); - for (int i = 0; i < rowPointersArrayRCP.size(); i++) - rowPointersArrayRCP[i] = rowPointers[i]-1; - Teuchos::ArrayRCP columnIndicesArrayRCP(columnIndices.size()); - for (int i = 0; i < columnIndicesArrayRCP.size(); i++) - columnIndicesArrayRCP[i] = columnIndices[i]-1; - $self->setAllIndices(rowPointersArrayRCP, columnIndicesArrayRCP); - } // NOTE: This is semantically different function from Tpetra. Here, we *require* that user already allocated the arrays to store the data void getNodeRowPtrs(Teuchos::ArrayView rowPointers) const { auto rowPointersArrayRCP = $self->getNodeRowPtrs(); diff --git a/src/tpetra/src/Tpetra_CrsMatrix.i b/src/tpetra/src/Tpetra_CrsMatrix.i index da4c2122..7e295725 100644 --- a/src/tpetra/src/Tpetra_CrsMatrix.i +++ b/src/tpetra/src/Tpetra_CrsMatrix.i @@ -19,7 +19,6 @@ // Ignore Details namespace %ignore Details; %ignore Tpetra::CrsMatrix::pack_functor; -%ignore Tpetra::CrsMatrix::getNode; // Ignore implementation details %ignore Tpetra::CrsMatrix::checkSizes; %ignore Tpetra::CrsMatrix::copyAndPermute; @@ -62,8 +61,6 @@ %ignore Tpetra::CrsMatrix::sumIntoGlobalValues (const GlobalOrdinal globalRow, const LocalOrdinal numEnt, const Scalar vals[], const GlobalOrdinal cols[], const bool atomic=useAtomicUpdatesByDefault); // prefer ArrayView variant %ignore Tpetra::CrsMatrix::sumIntoLocalValues (const LocalOrdinal localRow, const typename UnmanagedView< LocalIndicesViewType >::type &inputInds, const typename UnmanagedView< ImplScalarViewType >::type &inputVals, const bool atomic=useAtomicUpdatesByDefault) const; // needs Kokkos::UnmanagedView %ignore Tpetra::CrsMatrix::sumIntoLocalValues (const LocalOrdinal localRow, const LocalOrdinal numEnt, const Scalar vals[], const LocalOrdinal cols[], const bool atomic=useAtomicUpdatesByDefault) const; // prefer ArrayView variant -%ignore Tpetra::CrsMatrix::operator(); // needs operator() treatment -%ignore Tpetra::CrsMatrix::describe; // needs Teuchos::FancyOStream %ignore Tpetra::CrsMatrix::add; // needs Tpetra::RowMatrix %ignore Tpetra::CrsMatrix::getGraph; // needs Tpetra::RowGraph %ignore Tpetra::CrsMatrix::getLocalDiagCopy; // needs Tpetra::Vector diff --git a/src/tpetra/src/Tpetra_DistObject.i b/src/tpetra/src/Tpetra_DistObject.i index 46a21f4f..cc04774b 100644 --- a/src/tpetra/src/Tpetra_DistObject.i +++ b/src/tpetra/src/Tpetra_DistObject.i @@ -20,8 +20,6 @@ // ======================================================================= // Postpone temporarily // ======================================================================= -%ignore Tpetra::DistObject::print; // needs std::ostream -%ignore Tpetra::DistObject::describe; // needs Teuchos::FancyOStream %teuchos_rcp(Tpetra::SrcDistObject); %include "Tpetra_SrcDistObject.hpp" diff --git a/src/tpetra/src/Tpetra_Import_Export.i b/src/tpetra/src/Tpetra_Import_Export.i index b3baf0c7..86673940 100644 --- a/src/tpetra/src/Tpetra_Import_Export.i +++ b/src/tpetra/src/Tpetra_Import_Export.i @@ -34,9 +34,6 @@ %ignore Tpetra::Export::getExportLIDs; // ±1 issue %ignore Tpetra::Export::getExportPIDs; // ±1 issue %ignore Tpetra::Export::getDistributor; // needs Tpetra::Distributor -%ignore Tpetra::Export::operator=; // needs operator= -%ignore Tpetra::Export::describe; // needs Teuchos::FancyOStream -%ignore Tpetra::Export::print; // needs std::ostream %ignore Tpetra::Import::Import(const Teuchos::RCP< const map_type > &source, const Teuchos::RCP< const map_type > &target, @@ -72,9 +69,6 @@ %ignore Tpetra::Import::getExportPIDs; // ±1 issue %ignore Tpetra::Import::findUnionTargetGIDs; // ±1 issue %ignore Tpetra::Import::getDistributor; // needs Tpetra::Distributor -%ignore Tpetra::Import::operator=; // needs operator= -%ignore Tpetra::Import::describe; // needs Teuchos::FancyOStream -%ignore Tpetra::Import::print; // needs std::ostream // ======================================================================= // Instantiate diff --git a/src/tpetra/src/Tpetra_InOut.i b/src/tpetra/src/Tpetra_InOut.i index da9c1fd3..0d3802d5 100644 --- a/src/tpetra/src/Tpetra_InOut.i +++ b/src/tpetra/src/Tpetra_InOut.i @@ -20,7 +20,7 @@ // ======================================================================= // Ignore permanently // ======================================================================= -// Ignore everything as all require std::string, and carefully extend + %ignore Tpetra::MatrixMarket::Reader::readSparseGraph; %ignore Tpetra::MatrixMarket::Reader::readSparse; %ignore Tpetra::MatrixMarket::Reader::readDense; @@ -85,6 +85,7 @@ Tpetra::MatrixMarket::Writer::writeDenseFile(filename, X); } } + %ignore Tpetra::MatrixMarket::Reader::readSparseGraphFile; %ignore Tpetra::MatrixMarket::Reader::readSparseFile; %ignore Tpetra::MatrixMarket::Reader::readDenseFile; diff --git a/src/tpetra/src/Tpetra_Map.i b/src/tpetra/src/Tpetra_Map.i index a980c550..84d05cec 100644 --- a/src/tpetra/src/Tpetra_Map.i +++ b/src/tpetra/src/Tpetra_Map.i @@ -24,7 +24,6 @@ %ignore Tpetra::Map::Map(const global_size_t numGlobalElements, const GlobalOrdinal indexList[], const LocalOrdinal indexListSize, const GlobalOrdinal indexBase, const Teuchos::RCP< const Teuchos::Comm< int > > &comm); // superseded by Teuchos::ArrayView version -%ignore Tpetra::Map::getNode; // ======================================================================= // Postpone temporarily @@ -33,7 +32,6 @@ const Kokkos::View& indexList, const GlobalOrdinal indexBase, const Teuchos::RCP >& comm); // needs Kokkos::View -%ignore Tpetra::Map::describe; // needs Teuchos::FancyOStream %ignore Tpetra::Map::getLocalMap; // no need to expose this yet %ignore Tpetra::Map::getMyGlobalIndices; // return type is not exposed externally, requires using `auto`; for now, use getNodeElementList diff --git a/src/tpetra/src/fortpetra.i b/src/tpetra/src/fortpetra.i index 6c01ac94..d4f8da30 100644 --- a/src/tpetra/src/fortpetra.i +++ b/src/tpetra/src/fortpetra.i @@ -104,12 +104,14 @@ public :: norm_type // All enums should be prefaced with Tpetra %rename("Tpetra%s", %$isenumitem) ""; %rename("Tpetra%s", %$isenum) ""; +// Ignore implementation functions %rename("$ignore", regextarget=1) "Impl$"; %include "Tpetra_ConfigDefs.i" -// Ignore indexBase (Map, CrsGraph, CrsMatrix) +// Ignore indexBase, getNode (Map, CrsGraph, CrsMatrix) %ignore getIndexBase; +%ignore getNode; // Order matters!!! %include "Tpetra_Map.i" diff --git a/src/tpetra/src/swig/fortpetra.F90 b/src/tpetra/src/swig/fortpetra.F90 index 362933ff..06174872 100644 --- a/src/tpetra/src/swig/fortpetra.F90 +++ b/src/tpetra/src/swig/fortpetra.F90 @@ -162,6 +162,9 @@ module fortpetra module procedure new_TpetraMap__SWIG_6 module procedure new_TpetraMap__SWIG_7 end interface + type, public :: SWIGTYPE_std__ostream + type(SwigClassWrapper), public :: swigdata + end type ! class Tpetra::Import< LO,GO,NO > type, public :: TpetraImport type(SwigClassWrapper), public :: swigdata @@ -178,6 +181,7 @@ module fortpetra procedure, private :: setUnion__SWIG_0 => swigf_TpetraImport_setUnion__SWIG_0 procedure, private :: setUnion__SWIG_1 => swigf_TpetraImport_setUnion__SWIG_1 procedure :: createRemoteOnlyImport => swigf_TpetraImport_createRemoteOnlyImport + procedure :: print => swigf_TpetraImport_print procedure, private :: swigf_assignment_TpetraImport generic :: assignment(=) => swigf_assignment_TpetraImport generic :: setUnion => setUnion__SWIG_0, setUnion__SWIG_1 @@ -201,6 +205,7 @@ module fortpetra procedure :: getSourceMap => swigf_TpetraExport_getSourceMap procedure :: getTargetMap => swigf_TpetraExport_getTargetMap procedure :: isLocallyComplete => swigf_TpetraExport_isLocallyComplete + procedure :: print => swigf_TpetraExport_print procedure, private :: swigf_assignment_TpetraExport generic :: assignment(=) => swigf_assignment_TpetraExport end type TpetraExport @@ -1221,6 +1226,14 @@ function swigc_TpetraImport_createRemoteOnlyImport(farg1, farg2) & type(SwigClassWrapper) :: fresult end function +subroutine swigc_TpetraImport_print(farg1, farg2) & +bind(C, name="_wrap_TpetraImport_print") +use, intrinsic :: ISO_C_BINDING +import :: swigclasswrapper +type(SwigClassWrapper) :: farg1 +type(SwigClassWrapper) :: farg2 +end subroutine + subroutine swigc_assignment_TpetraImport(self, other) & bind(C, name="_wrap_assign_TpetraImport") use, intrinsic :: ISO_C_BINDING @@ -1345,6 +1358,14 @@ function swigc_TpetraExport_isLocallyComplete(farg1) & integer(C_INT) :: fresult end function +subroutine swigc_TpetraExport_print(farg1, farg2) & +bind(C, name="_wrap_TpetraExport_print") +use, intrinsic :: ISO_C_BINDING +import :: swigclasswrapper +type(SwigClassWrapper) :: farg1 +type(SwigClassWrapper) :: farg2 +end subroutine + subroutine swigc_assignment_TpetraExport(self, other) & bind(C, name="_wrap_assign_TpetraExport") use, intrinsic :: ISO_C_BINDING @@ -5674,6 +5695,20 @@ function swigf_TpetraImport_createRemoteOnlyImport(self, remotetarget) & swig_result%swigdata = fresult end function +subroutine swigf_TpetraImport_print(self, os) +use, intrinsic :: ISO_C_BINDING +class(TpetraImport), intent(in) :: self + +class(SWIGTYPE_std__ostream), intent(inout) :: os + +type(SwigClassWrapper) :: farg1 +type(SwigClassWrapper) :: farg2 + +farg1 = self%swigdata +farg2 = os%swigdata +call swigc_TpetraImport_print(farg1, farg2) +end subroutine + subroutine swigf_assignment_TpetraImport(self, other) use, intrinsic :: ISO_C_BINDING class(TpetraImport), intent(inout) :: self @@ -5874,6 +5909,20 @@ function swigf_TpetraExport_isLocallyComplete(self) & swig_result = SWIG_int_to_logical(fresult) end function +subroutine swigf_TpetraExport_print(self, os) +use, intrinsic :: ISO_C_BINDING +class(TpetraExport), intent(in) :: self + +class(SWIGTYPE_std__ostream), intent(inout) :: os + +type(SwigClassWrapper) :: farg1 +type(SwigClassWrapper) :: farg2 + +farg1 = self%swigdata +farg2 = os%swigdata +call swigc_TpetraExport_print(farg1, farg2) +end subroutine + subroutine swigf_assignment_TpetraExport(self, other) use, intrinsic :: ISO_C_BINDING class(TpetraExport), intent(inout) :: self diff --git a/src/tpetra/src/swig/fortpetraFORTRAN_wrap.cxx b/src/tpetra/src/swig/fortpetraFORTRAN_wrap.cxx index 12200542..5480bdba 100644 --- a/src/tpetra/src/swig/fortpetraFORTRAN_wrap.cxx +++ b/src/tpetra/src/swig/fortpetraFORTRAN_wrap.cxx @@ -2977,6 +2977,42 @@ SWIGEXPORT SwigClassWrapper _wrap_TpetraImport_createRemoteOnlyImport(SwigClassW } +SWIGEXPORT void _wrap_TpetraImport_print(SwigClassWrapper const *farg1, SwigClassWrapper const *farg2) { + Tpetra::Import< LO,GO,NO > *arg1 = (Tpetra::Import< LO,GO,NO > *) 0 ; + std::ostream *arg2 = 0 ; + Teuchos::RCP< Tpetra::Import< LO,GO,NO > const > *smartarg1 ; + + smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::Import* >(smartarg1->get()) : NULL; + SWIG_check_mutable_nonnull(*farg2, "std::ostream &", "SWIGTYPE_std__ostream", "Tpetra::Import< LO,GO,NO >::print(std::ostream &) const", return ); + arg2 = static_cast< std::ostream * >(farg2->cptr); + { + // Make sure no unhandled exceptions exist before performing a new action + SWIG_check_unhandled_exception_impl("Tpetra::Import< LO,GO,NO >::print(std::ostream &) const");; + try + { + // Attempt the wrapped function call + ((Tpetra::Import< LO,GO,NO > const *)arg1)->print(*arg2); + } + catch (const std::range_error& e) + { + // Store a C++ exception + SWIG_exception_impl("Tpetra::Import< LO,GO,NO >::print(std::ostream &) const", SWIG_IndexError, e.what(), return ); + } + catch (const std::exception& e) + { + // Store a C++ exception + SWIG_exception_impl("Tpetra::Import< LO,GO,NO >::print(std::ostream &) const", SWIG_RuntimeError, e.what(), return ); + } + catch (...) + { + SWIG_exception_impl("Tpetra::Import< LO,GO,NO >::print(std::ostream &) const", SWIG_UnknownError, "An unknown exception occurred", return ); + } + } + +} + + SWIGEXPORT void _wrap_assign_TpetraImport(SwigClassWrapper * self, SwigClassWrapper const * other) { typedef Teuchos::RCP< Tpetra::Import > swig_lhs_classtype; SWIG_assign(swig_lhs_classtype, self, @@ -3465,6 +3501,42 @@ SWIGEXPORT int _wrap_TpetraExport_isLocallyComplete(SwigClassWrapper const *farg } +SWIGEXPORT void _wrap_TpetraExport_print(SwigClassWrapper const *farg1, SwigClassWrapper const *farg2) { + Tpetra::Export< LO,GO,NO > *arg1 = (Tpetra::Export< LO,GO,NO > *) 0 ; + std::ostream *arg2 = 0 ; + Teuchos::RCP< Tpetra::Export< LO,GO,NO > const > *smartarg1 ; + + smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::Export* >(smartarg1->get()) : NULL; + SWIG_check_mutable_nonnull(*farg2, "std::ostream &", "SWIGTYPE_std__ostream", "Tpetra::Export< LO,GO,NO >::print(std::ostream &) const", return ); + arg2 = static_cast< std::ostream * >(farg2->cptr); + { + // Make sure no unhandled exceptions exist before performing a new action + SWIG_check_unhandled_exception_impl("Tpetra::Export< LO,GO,NO >::print(std::ostream &) const");; + try + { + // Attempt the wrapped function call + ((Tpetra::Export< LO,GO,NO > const *)arg1)->print(*arg2); + } + catch (const std::range_error& e) + { + // Store a C++ exception + SWIG_exception_impl("Tpetra::Export< LO,GO,NO >::print(std::ostream &) const", SWIG_IndexError, e.what(), return ); + } + catch (const std::exception& e) + { + // Store a C++ exception + SWIG_exception_impl("Tpetra::Export< LO,GO,NO >::print(std::ostream &) const", SWIG_RuntimeError, e.what(), return ); + } + catch (...) + { + SWIG_exception_impl("Tpetra::Export< LO,GO,NO >::print(std::ostream &) const", SWIG_UnknownError, "An unknown exception occurred", return ); + } + } + +} + + SWIGEXPORT void _wrap_assign_TpetraExport(SwigClassWrapper * self, SwigClassWrapper const * other) { typedef Teuchos::RCP< Tpetra::Export > swig_lhs_classtype; SWIG_assign(swig_lhs_classtype, self, From 993f275cb5b6044544af91ce4f05a075e4e1c384 Mon Sep 17 00:00:00 2001 From: Seth R Johnson Date: Mon, 4 Feb 2019 10:54:13 -0500 Subject: [PATCH 21/40] Remove deprecated tpetra methods --- src/tpetra/src/Tpetra_CrsGraph.i | 7 + src/tpetra/src/fortpetra.i | 10 +- src/tpetra/src/swig/fortpetra.F90 | 192 ------------ src/tpetra/src/swig/fortpetraFORTRAN_wrap.cxx | 288 ------------------ src/tpetra/test/test_tpetra_crsgraph.F90 | 4 - src/tpetra/test/test_tpetra_crsmatrix.F90 | 4 - 6 files changed, 15 insertions(+), 490 deletions(-) diff --git a/src/tpetra/src/Tpetra_CrsGraph.i b/src/tpetra/src/Tpetra_CrsGraph.i index be9ad910..8d47bff7 100644 --- a/src/tpetra/src/Tpetra_CrsGraph.i +++ b/src/tpetra/src/Tpetra_CrsGraph.i @@ -18,6 +18,7 @@ // ======================================================================= // Ignore permanently // ======================================================================= + %ignore Tpetra::CrsGraph::checkSizes; %ignore Tpetra::CrsGraph::copyAndPermute; %ignore Tpetra::CrsGraph::packAndPrepare; @@ -27,6 +28,12 @@ %ignore Tpetra::CrsGraph::SLocalGlobalViews; %ignore Tpetra::CrsGraph::SLocalGlobalNCViews; +// Depreceated functions +%ignore Tpetra::CrsGraph::getGlobalNumDiags; +%ignore Tpetra::CrsGraph::getNodeNumDiags; +%ignore Tpetra::CrsGraph::isLowerTriangular; +%ignore Tpetra::CrsGraph::isUpperTriangular; + // ======================================================================= // Postpone temporarily // ======================================================================= diff --git a/src/tpetra/src/fortpetra.i b/src/tpetra/src/fortpetra.i index d4f8da30..d0895b02 100644 --- a/src/tpetra/src/fortpetra.i +++ b/src/tpetra/src/fortpetra.i @@ -110,8 +110,14 @@ public :: norm_type %include "Tpetra_ConfigDefs.i" // Ignore indexBase, getNode (Map, CrsGraph, CrsMatrix) -%ignore getIndexBase; -%ignore getNode; +%ignore *::getIndexBase; +%ignore *::getNode; + +// Ignore depreceated functions (CrsGraph, CrsMatrix) +%ignore *::getGlobalNumDiags; +%ignore *::getNodeNumDiags; +%ignore *::isLowerTriangular; +%ignore *::isUpperTriangular; // Order matters!!! %include "Tpetra_Map.i" diff --git a/src/tpetra/src/swig/fortpetra.F90 b/src/tpetra/src/swig/fortpetra.F90 index 06174872..c162c752 100644 --- a/src/tpetra/src/swig/fortpetra.F90 +++ b/src/tpetra/src/swig/fortpetra.F90 @@ -405,13 +405,9 @@ module fortpetra procedure :: getNodeAllocationSize => swigf_TpetraCrsGraph_getNodeAllocationSize procedure :: getNumAllocatedEntriesInGlobalRow => swigf_TpetraCrsGraph_getNumAllocatedEntriesInGlobalRow procedure :: getNumAllocatedEntriesInLocalRow => swigf_TpetraCrsGraph_getNumAllocatedEntriesInLocalRow - procedure :: getGlobalNumDiags => swigf_TpetraCrsGraph_getGlobalNumDiags - procedure :: getNodeNumDiags => swigf_TpetraCrsGraph_getNodeNumDiags procedure :: getGlobalMaxNumRowEntries => swigf_TpetraCrsGraph_getGlobalMaxNumRowEntries procedure :: getNodeMaxNumRowEntries => swigf_TpetraCrsGraph_getNodeMaxNumRowEntries procedure :: hasColMap => swigf_TpetraCrsGraph_hasColMap - procedure :: isLowerTriangular => swigf_TpetraCrsGraph_isLowerTriangular - procedure :: isUpperTriangular => swigf_TpetraCrsGraph_isUpperTriangular procedure :: isLocallyIndexed => swigf_TpetraCrsGraph_isLocallyIndexed procedure :: isGloballyIndexed => swigf_TpetraCrsGraph_isGloballyIndexed procedure :: isFillComplete => swigf_TpetraCrsGraph_isFillComplete @@ -528,13 +524,9 @@ module fortpetra procedure :: getNodeNumEntries => swigf_TpetraCrsMatrix_getNodeNumEntries procedure :: getNumEntriesInGlobalRow => swigf_TpetraCrsMatrix_getNumEntriesInGlobalRow procedure :: getNumEntriesInLocalRow => swigf_TpetraCrsMatrix_getNumEntriesInLocalRow - procedure :: getGlobalNumDiags => swigf_TpetraCrsMatrix_getGlobalNumDiags - procedure :: getNodeNumDiags => swigf_TpetraCrsMatrix_getNodeNumDiags procedure :: getGlobalMaxNumRowEntries => swigf_TpetraCrsMatrix_getGlobalMaxNumRowEntries procedure :: getNodeMaxNumRowEntries => swigf_TpetraCrsMatrix_getNodeMaxNumRowEntries procedure :: hasColMap => swigf_TpetraCrsMatrix_hasColMap - procedure :: isLowerTriangular => swigf_TpetraCrsMatrix_isLowerTriangular - procedure :: isUpperTriangular => swigf_TpetraCrsMatrix_isUpperTriangular procedure :: isLocallyIndexed => swigf_TpetraCrsMatrix_isLocallyIndexed procedure :: isGloballyIndexed => swigf_TpetraCrsMatrix_isGloballyIndexed procedure :: isFillComplete => swigf_TpetraCrsMatrix_isFillComplete @@ -2603,24 +2595,6 @@ function swigc_TpetraCrsGraph_getNumAllocatedEntriesInLocalRow(farg1, farg2) & integer(C_INT) :: fresult end function -function swigc_TpetraCrsGraph_getGlobalNumDiags(farg1) & -bind(C, name="_wrap_TpetraCrsGraph_getGlobalNumDiags") & -result(fresult) -use, intrinsic :: ISO_C_BINDING -import :: swigclasswrapper -type(SwigClassWrapper) :: farg1 -integer(C_LONG) :: fresult -end function - -function swigc_TpetraCrsGraph_getNodeNumDiags(farg1) & -bind(C, name="_wrap_TpetraCrsGraph_getNodeNumDiags") & -result(fresult) -use, intrinsic :: ISO_C_BINDING -import :: swigclasswrapper -type(SwigClassWrapper) :: farg1 -integer(C_SIZE_T) :: fresult -end function - function swigc_TpetraCrsGraph_getGlobalMaxNumRowEntries(farg1) & bind(C, name="_wrap_TpetraCrsGraph_getGlobalMaxNumRowEntries") & result(fresult) @@ -2648,24 +2622,6 @@ function swigc_TpetraCrsGraph_hasColMap(farg1) & integer(C_INT) :: fresult end function -function swigc_TpetraCrsGraph_isLowerTriangular(farg1) & -bind(C, name="_wrap_TpetraCrsGraph_isLowerTriangular") & -result(fresult) -use, intrinsic :: ISO_C_BINDING -import :: swigclasswrapper -type(SwigClassWrapper) :: farg1 -integer(C_INT) :: fresult -end function - -function swigc_TpetraCrsGraph_isUpperTriangular(farg1) & -bind(C, name="_wrap_TpetraCrsGraph_isUpperTriangular") & -result(fresult) -use, intrinsic :: ISO_C_BINDING -import :: swigclasswrapper -type(SwigClassWrapper) :: farg1 -integer(C_INT) :: fresult -end function - function swigc_TpetraCrsGraph_isLocallyIndexed(farg1) & bind(C, name="_wrap_TpetraCrsGraph_isLocallyIndexed") & result(fresult) @@ -3579,24 +3535,6 @@ function swigc_TpetraCrsMatrix_getNumEntriesInLocalRow(farg1, farg2) & integer(C_INT) :: fresult end function -function swigc_TpetraCrsMatrix_getGlobalNumDiags(farg1) & -bind(C, name="_wrap_TpetraCrsMatrix_getGlobalNumDiags") & -result(fresult) -use, intrinsic :: ISO_C_BINDING -import :: swigclasswrapper -type(SwigClassWrapper) :: farg1 -integer(C_LONG) :: fresult -end function - -function swigc_TpetraCrsMatrix_getNodeNumDiags(farg1) & -bind(C, name="_wrap_TpetraCrsMatrix_getNodeNumDiags") & -result(fresult) -use, intrinsic :: ISO_C_BINDING -import :: swigclasswrapper -type(SwigClassWrapper) :: farg1 -integer(C_SIZE_T) :: fresult -end function - function swigc_TpetraCrsMatrix_getGlobalMaxNumRowEntries(farg1) & bind(C, name="_wrap_TpetraCrsMatrix_getGlobalMaxNumRowEntries") & result(fresult) @@ -3624,24 +3562,6 @@ function swigc_TpetraCrsMatrix_hasColMap(farg1) & integer(C_INT) :: fresult end function -function swigc_TpetraCrsMatrix_isLowerTriangular(farg1) & -bind(C, name="_wrap_TpetraCrsMatrix_isLowerTriangular") & -result(fresult) -use, intrinsic :: ISO_C_BINDING -import :: swigclasswrapper -type(SwigClassWrapper) :: farg1 -integer(C_INT) :: fresult -end function - -function swigc_TpetraCrsMatrix_isUpperTriangular(farg1) & -bind(C, name="_wrap_TpetraCrsMatrix_isUpperTriangular") & -result(fresult) -use, intrinsic :: ISO_C_BINDING -import :: swigclasswrapper -type(SwigClassWrapper) :: farg1 -integer(C_INT) :: fresult -end function - function swigc_TpetraCrsMatrix_isLocallyIndexed(farg1) & bind(C, name="_wrap_TpetraCrsMatrix_isLocallyIndexed") & result(fresult) @@ -8255,34 +8175,6 @@ function swigf_TpetraCrsGraph_getNumAllocatedEntriesInLocalRow(self, localrow) & swig_result = int(fresult) end function -function swigf_TpetraCrsGraph_getGlobalNumDiags(self) & -result(swig_result) -use, intrinsic :: ISO_C_BINDING -integer(C_LONG) :: swig_result -class(TpetraCrsGraph), intent(in) :: self - -integer(C_LONG) :: fresult -type(SwigClassWrapper) :: farg1 - -farg1 = self%swigdata -fresult = swigc_TpetraCrsGraph_getGlobalNumDiags(farg1) -swig_result = fresult -end function - -function swigf_TpetraCrsGraph_getNodeNumDiags(self) & -result(swig_result) -use, intrinsic :: ISO_C_BINDING -integer(C_SIZE_T) :: swig_result -class(TpetraCrsGraph), intent(in) :: self - -integer(C_SIZE_T) :: fresult -type(SwigClassWrapper) :: farg1 - -farg1 = self%swigdata -fresult = swigc_TpetraCrsGraph_getNodeNumDiags(farg1) -swig_result = fresult -end function - function swigf_TpetraCrsGraph_getGlobalMaxNumRowEntries(self) & result(swig_result) use, intrinsic :: ISO_C_BINDING @@ -8325,34 +8217,6 @@ function swigf_TpetraCrsGraph_hasColMap(self) & swig_result = SWIG_int_to_logical(fresult) end function -function swigf_TpetraCrsGraph_isLowerTriangular(self) & -result(swig_result) -use, intrinsic :: ISO_C_BINDING -logical :: swig_result -class(TpetraCrsGraph), intent(in) :: self - -integer(C_INT) :: fresult -type(SwigClassWrapper) :: farg1 - -farg1 = self%swigdata -fresult = swigc_TpetraCrsGraph_isLowerTriangular(farg1) -swig_result = SWIG_int_to_logical(fresult) -end function - -function swigf_TpetraCrsGraph_isUpperTriangular(self) & -result(swig_result) -use, intrinsic :: ISO_C_BINDING -logical :: swig_result -class(TpetraCrsGraph), intent(in) :: self - -integer(C_INT) :: fresult -type(SwigClassWrapper) :: farg1 - -farg1 = self%swigdata -fresult = swigc_TpetraCrsGraph_isUpperTriangular(farg1) -swig_result = SWIG_int_to_logical(fresult) -end function - function swigf_TpetraCrsGraph_isLocallyIndexed(self) & result(swig_result) use, intrinsic :: ISO_C_BINDING @@ -10158,34 +10022,6 @@ function swigf_TpetraCrsMatrix_getNumEntriesInLocalRow(self, localrow) & swig_result = int(fresult) end function -function swigf_TpetraCrsMatrix_getGlobalNumDiags(self) & -result(swig_result) -use, intrinsic :: ISO_C_BINDING -integer(C_LONG) :: swig_result -class(TpetraCrsMatrix), intent(in) :: self - -integer(C_LONG) :: fresult -type(SwigClassWrapper) :: farg1 - -farg1 = self%swigdata -fresult = swigc_TpetraCrsMatrix_getGlobalNumDiags(farg1) -swig_result = fresult -end function - -function swigf_TpetraCrsMatrix_getNodeNumDiags(self) & -result(swig_result) -use, intrinsic :: ISO_C_BINDING -integer(C_SIZE_T) :: swig_result -class(TpetraCrsMatrix), intent(in) :: self - -integer(C_SIZE_T) :: fresult -type(SwigClassWrapper) :: farg1 - -farg1 = self%swigdata -fresult = swigc_TpetraCrsMatrix_getNodeNumDiags(farg1) -swig_result = fresult -end function - function swigf_TpetraCrsMatrix_getGlobalMaxNumRowEntries(self) & result(swig_result) use, intrinsic :: ISO_C_BINDING @@ -10228,34 +10064,6 @@ function swigf_TpetraCrsMatrix_hasColMap(self) & swig_result = SWIG_int_to_logical(fresult) end function -function swigf_TpetraCrsMatrix_isLowerTriangular(self) & -result(swig_result) -use, intrinsic :: ISO_C_BINDING -logical :: swig_result -class(TpetraCrsMatrix), intent(in) :: self - -integer(C_INT) :: fresult -type(SwigClassWrapper) :: farg1 - -farg1 = self%swigdata -fresult = swigc_TpetraCrsMatrix_isLowerTriangular(farg1) -swig_result = SWIG_int_to_logical(fresult) -end function - -function swigf_TpetraCrsMatrix_isUpperTriangular(self) & -result(swig_result) -use, intrinsic :: ISO_C_BINDING -logical :: swig_result -class(TpetraCrsMatrix), intent(in) :: self - -integer(C_INT) :: fresult -type(SwigClassWrapper) :: farg1 - -farg1 = self%swigdata -fresult = swigc_TpetraCrsMatrix_isUpperTriangular(farg1) -swig_result = SWIG_int_to_logical(fresult) -end function - function swigf_TpetraCrsMatrix_isLocallyIndexed(self) & result(swig_result) use, intrinsic :: ISO_C_BINDING diff --git a/src/tpetra/src/swig/fortpetraFORTRAN_wrap.cxx b/src/tpetra/src/swig/fortpetraFORTRAN_wrap.cxx index 5480bdba..0cdc7308 100644 --- a/src/tpetra/src/swig/fortpetraFORTRAN_wrap.cxx +++ b/src/tpetra/src/swig/fortpetraFORTRAN_wrap.cxx @@ -8397,78 +8397,6 @@ SWIGEXPORT int _wrap_TpetraCrsGraph_getNumAllocatedEntriesInLocalRow(SwigClassWr } -SWIGEXPORT long _wrap_TpetraCrsGraph_getGlobalNumDiags(SwigClassWrapper const *farg1) { - long fresult ; - Tpetra::CrsGraph< LO,GO,NO > *arg1 = (Tpetra::CrsGraph< LO,GO,NO > *) 0 ; - Teuchos::RCP< Tpetra::CrsGraph< LO,GO,NO > const > *smartarg1 ; - Tpetra::global_size_t result; - - smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); - arg1 = smartarg1 ? const_cast< Tpetra::CrsGraph* >(smartarg1->get()) : NULL; - { - // Make sure no unhandled exceptions exist before performing a new action - SWIG_check_unhandled_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::getGlobalNumDiags() const");; - try - { - // Attempt the wrapped function call - result = (Tpetra::global_size_t)((Tpetra::CrsGraph< LO,GO,NO > const *)arg1)->getGlobalNumDiags(); - } - catch (const std::range_error& e) - { - // Store a C++ exception - SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::getGlobalNumDiags() const", SWIG_IndexError, e.what(), return 0); - } - catch (const std::exception& e) - { - // Store a C++ exception - SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::getGlobalNumDiags() const", SWIG_RuntimeError, e.what(), return 0); - } - catch (...) - { - SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::getGlobalNumDiags() const", SWIG_UnknownError, "An unknown exception occurred", return 0); - } - } - fresult = static_cast< Tpetra::global_size_t >(result); - return fresult; -} - - -SWIGEXPORT size_t _wrap_TpetraCrsGraph_getNodeNumDiags(SwigClassWrapper const *farg1) { - size_t fresult ; - Tpetra::CrsGraph< LO,GO,NO > *arg1 = (Tpetra::CrsGraph< LO,GO,NO > *) 0 ; - Teuchos::RCP< Tpetra::CrsGraph< LO,GO,NO > const > *smartarg1 ; - size_t result; - - smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); - arg1 = smartarg1 ? const_cast< Tpetra::CrsGraph* >(smartarg1->get()) : NULL; - { - // Make sure no unhandled exceptions exist before performing a new action - SWIG_check_unhandled_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::getNodeNumDiags() const");; - try - { - // Attempt the wrapped function call - result = (size_t)((Tpetra::CrsGraph< LO,GO,NO > const *)arg1)->getNodeNumDiags(); - } - catch (const std::range_error& e) - { - // Store a C++ exception - SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::getNodeNumDiags() const", SWIG_IndexError, e.what(), return 0); - } - catch (const std::exception& e) - { - // Store a C++ exception - SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::getNodeNumDiags() const", SWIG_RuntimeError, e.what(), return 0); - } - catch (...) - { - SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::getNodeNumDiags() const", SWIG_UnknownError, "An unknown exception occurred", return 0); - } - } - fresult = static_cast< size_t >(result); - return fresult; -} - - SWIGEXPORT size_t _wrap_TpetraCrsGraph_getGlobalMaxNumRowEntries(SwigClassWrapper const *farg1) { size_t fresult ; Tpetra::CrsGraph< LO,GO,NO > *arg1 = (Tpetra::CrsGraph< LO,GO,NO > *) 0 ; @@ -8577,78 +8505,6 @@ SWIGEXPORT int _wrap_TpetraCrsGraph_hasColMap(SwigClassWrapper const *farg1) { } -SWIGEXPORT int _wrap_TpetraCrsGraph_isLowerTriangular(SwigClassWrapper const *farg1) { - int fresult ; - Tpetra::CrsGraph< LO,GO,NO > *arg1 = (Tpetra::CrsGraph< LO,GO,NO > *) 0 ; - Teuchos::RCP< Tpetra::CrsGraph< LO,GO,NO > const > *smartarg1 ; - bool result; - - smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); - arg1 = smartarg1 ? const_cast< Tpetra::CrsGraph* >(smartarg1->get()) : NULL; - { - // Make sure no unhandled exceptions exist before performing a new action - SWIG_check_unhandled_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::isLowerTriangular() const");; - try - { - // Attempt the wrapped function call - result = (bool)((Tpetra::CrsGraph< LO,GO,NO > const *)arg1)->isLowerTriangular(); - } - catch (const std::range_error& e) - { - // Store a C++ exception - SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::isLowerTriangular() const", SWIG_IndexError, e.what(), return 0); - } - catch (const std::exception& e) - { - // Store a C++ exception - SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::isLowerTriangular() const", SWIG_RuntimeError, e.what(), return 0); - } - catch (...) - { - SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::isLowerTriangular() const", SWIG_UnknownError, "An unknown exception occurred", return 0); - } - } - fresult = (result ? 1 : 0); - return fresult; -} - - -SWIGEXPORT int _wrap_TpetraCrsGraph_isUpperTriangular(SwigClassWrapper const *farg1) { - int fresult ; - Tpetra::CrsGraph< LO,GO,NO > *arg1 = (Tpetra::CrsGraph< LO,GO,NO > *) 0 ; - Teuchos::RCP< Tpetra::CrsGraph< LO,GO,NO > const > *smartarg1 ; - bool result; - - smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); - arg1 = smartarg1 ? const_cast< Tpetra::CrsGraph* >(smartarg1->get()) : NULL; - { - // Make sure no unhandled exceptions exist before performing a new action - SWIG_check_unhandled_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::isUpperTriangular() const");; - try - { - // Attempt the wrapped function call - result = (bool)((Tpetra::CrsGraph< LO,GO,NO > const *)arg1)->isUpperTriangular(); - } - catch (const std::range_error& e) - { - // Store a C++ exception - SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::isUpperTriangular() const", SWIG_IndexError, e.what(), return 0); - } - catch (const std::exception& e) - { - // Store a C++ exception - SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::isUpperTriangular() const", SWIG_RuntimeError, e.what(), return 0); - } - catch (...) - { - SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::isUpperTriangular() const", SWIG_UnknownError, "An unknown exception occurred", return 0); - } - } - fresult = (result ? 1 : 0); - return fresult; -} - - SWIGEXPORT int _wrap_TpetraCrsGraph_isLocallyIndexed(SwigClassWrapper const *farg1) { int fresult ; Tpetra::CrsGraph< LO,GO,NO > *arg1 = (Tpetra::CrsGraph< LO,GO,NO > *) 0 ; @@ -12307,78 +12163,6 @@ SWIGEXPORT int _wrap_TpetraCrsMatrix_getNumEntriesInLocalRow(SwigClassWrapper co } -SWIGEXPORT long _wrap_TpetraCrsMatrix_getGlobalNumDiags(SwigClassWrapper const *farg1) { - long fresult ; - Tpetra::CrsMatrix< SC,LO,GO,NO > *arg1 = (Tpetra::CrsMatrix< SC,LO,GO,NO > *) 0 ; - Teuchos::RCP< Tpetra::CrsMatrix< SC,LO,GO,NO > const > *smartarg1 ; - Tpetra::global_size_t result; - - smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); - arg1 = smartarg1 ? const_cast< Tpetra::CrsMatrix* >(smartarg1->get()) : NULL; - { - // Make sure no unhandled exceptions exist before performing a new action - SWIG_check_unhandled_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::getGlobalNumDiags() const");; - try - { - // Attempt the wrapped function call - result = (Tpetra::global_size_t)((Tpetra::CrsMatrix< SC,LO,GO,NO > const *)arg1)->getGlobalNumDiags(); - } - catch (const std::range_error& e) - { - // Store a C++ exception - SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::getGlobalNumDiags() const", SWIG_IndexError, e.what(), return 0); - } - catch (const std::exception& e) - { - // Store a C++ exception - SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::getGlobalNumDiags() const", SWIG_RuntimeError, e.what(), return 0); - } - catch (...) - { - SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::getGlobalNumDiags() const", SWIG_UnknownError, "An unknown exception occurred", return 0); - } - } - fresult = static_cast< Tpetra::global_size_t >(result); - return fresult; -} - - -SWIGEXPORT size_t _wrap_TpetraCrsMatrix_getNodeNumDiags(SwigClassWrapper const *farg1) { - size_t fresult ; - Tpetra::CrsMatrix< SC,LO,GO,NO > *arg1 = (Tpetra::CrsMatrix< SC,LO,GO,NO > *) 0 ; - Teuchos::RCP< Tpetra::CrsMatrix< SC,LO,GO,NO > const > *smartarg1 ; - size_t result; - - smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); - arg1 = smartarg1 ? const_cast< Tpetra::CrsMatrix* >(smartarg1->get()) : NULL; - { - // Make sure no unhandled exceptions exist before performing a new action - SWIG_check_unhandled_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::getNodeNumDiags() const");; - try - { - // Attempt the wrapped function call - result = (size_t)((Tpetra::CrsMatrix< SC,LO,GO,NO > const *)arg1)->getNodeNumDiags(); - } - catch (const std::range_error& e) - { - // Store a C++ exception - SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::getNodeNumDiags() const", SWIG_IndexError, e.what(), return 0); - } - catch (const std::exception& e) - { - // Store a C++ exception - SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::getNodeNumDiags() const", SWIG_RuntimeError, e.what(), return 0); - } - catch (...) - { - SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::getNodeNumDiags() const", SWIG_UnknownError, "An unknown exception occurred", return 0); - } - } - fresult = static_cast< size_t >(result); - return fresult; -} - - SWIGEXPORT size_t _wrap_TpetraCrsMatrix_getGlobalMaxNumRowEntries(SwigClassWrapper const *farg1) { size_t fresult ; Tpetra::CrsMatrix< SC,LO,GO,NO > *arg1 = (Tpetra::CrsMatrix< SC,LO,GO,NO > *) 0 ; @@ -12487,78 +12271,6 @@ SWIGEXPORT int _wrap_TpetraCrsMatrix_hasColMap(SwigClassWrapper const *farg1) { } -SWIGEXPORT int _wrap_TpetraCrsMatrix_isLowerTriangular(SwigClassWrapper const *farg1) { - int fresult ; - Tpetra::CrsMatrix< SC,LO,GO,NO > *arg1 = (Tpetra::CrsMatrix< SC,LO,GO,NO > *) 0 ; - Teuchos::RCP< Tpetra::CrsMatrix< SC,LO,GO,NO > const > *smartarg1 ; - bool result; - - smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); - arg1 = smartarg1 ? const_cast< Tpetra::CrsMatrix* >(smartarg1->get()) : NULL; - { - // Make sure no unhandled exceptions exist before performing a new action - SWIG_check_unhandled_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::isLowerTriangular() const");; - try - { - // Attempt the wrapped function call - result = (bool)((Tpetra::CrsMatrix< SC,LO,GO,NO > const *)arg1)->isLowerTriangular(); - } - catch (const std::range_error& e) - { - // Store a C++ exception - SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::isLowerTriangular() const", SWIG_IndexError, e.what(), return 0); - } - catch (const std::exception& e) - { - // Store a C++ exception - SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::isLowerTriangular() const", SWIG_RuntimeError, e.what(), return 0); - } - catch (...) - { - SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::isLowerTriangular() const", SWIG_UnknownError, "An unknown exception occurred", return 0); - } - } - fresult = (result ? 1 : 0); - return fresult; -} - - -SWIGEXPORT int _wrap_TpetraCrsMatrix_isUpperTriangular(SwigClassWrapper const *farg1) { - int fresult ; - Tpetra::CrsMatrix< SC,LO,GO,NO > *arg1 = (Tpetra::CrsMatrix< SC,LO,GO,NO > *) 0 ; - Teuchos::RCP< Tpetra::CrsMatrix< SC,LO,GO,NO > const > *smartarg1 ; - bool result; - - smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); - arg1 = smartarg1 ? const_cast< Tpetra::CrsMatrix* >(smartarg1->get()) : NULL; - { - // Make sure no unhandled exceptions exist before performing a new action - SWIG_check_unhandled_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::isUpperTriangular() const");; - try - { - // Attempt the wrapped function call - result = (bool)((Tpetra::CrsMatrix< SC,LO,GO,NO > const *)arg1)->isUpperTriangular(); - } - catch (const std::range_error& e) - { - // Store a C++ exception - SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::isUpperTriangular() const", SWIG_IndexError, e.what(), return 0); - } - catch (const std::exception& e) - { - // Store a C++ exception - SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::isUpperTriangular() const", SWIG_RuntimeError, e.what(), return 0); - } - catch (...) - { - SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::isUpperTriangular() const", SWIG_UnknownError, "An unknown exception occurred", return 0); - } - } - fresult = (result ? 1 : 0); - return fresult; -} - - SWIGEXPORT int _wrap_TpetraCrsMatrix_isLocallyIndexed(SwigClassWrapper const *farg1) { int fresult ; Tpetra::CrsMatrix< SC,LO,GO,NO > *arg1 = (Tpetra::CrsMatrix< SC,LO,GO,NO > *) 0 ; diff --git a/src/tpetra/test/test_tpetra_crsgraph.F90 b/src/tpetra/test/test_tpetra_crsgraph.F90 index 725153dc..bc713573 100644 --- a/src/tpetra/test/test_tpetra_crsgraph.F90 +++ b/src/tpetra/test/test_tpetra_crsgraph.F90 @@ -512,10 +512,6 @@ program test_TpetraCrsGraph TEST_EQUALITY(i_LO, 1_size_type) i_LO = Graph%getNumAllocatedEntriesInLocalRow(lclrow) TEST_EQUALITY(i_LO, 1_size_type) - i_LO = Graph%getGlobalNumDiags() - TEST_EQUALITY(i_LO, int(commsize, kind=size_type)) - i_LO = Graph%getNodeNumDiags() - TEST_EQUALITY(i_LO, 1_size_type) i_LO = Graph%getGlobalMaxNumRowEntries() TEST_EQUALITY(i_LO, 1_size_type) i_LO = Graph%getNodeMaxNumRowEntries() diff --git a/src/tpetra/test/test_tpetra_crsmatrix.F90 b/src/tpetra/test/test_tpetra_crsmatrix.F90 index e63f9cdf..433deb10 100644 --- a/src/tpetra/test/test_tpetra_crsmatrix.F90 +++ b/src/tpetra/test/test_tpetra_crsmatrix.F90 @@ -98,8 +98,6 @@ program test_TpetraCrsMatrix TEST_ASSERT(Mat%getGlobalNumCols()==num_images*num_local) TEST_ASSERT(Mat%getNodeNumRows()==num_local) TEST_ASSERT(Mat%getNodeNumCols()==num_local) - TEST_ASSERT(Mat%getGlobalNumDiags()==num_images*num_local) - TEST_ASSERT(Mat%getNodeNumDiags()==num_local) TEST_ASSERT(Mat%getGlobalMaxNumRowEntries()==1) TEST_ASSERT(Mat%getNodeMaxNumRowEntries()==1) TEST_ASSERT(Mat%isFillComplete()) @@ -248,8 +246,6 @@ program test_TpetraCrsMatrix TEST_ASSERT(A%getGlobalNumRows()==num_images) TEST_ASSERT(A%getNodeNumRows()==1) TEST_ASSERT(A%getNodeNumCols()==nnz) - TEST_ASSERT(A%getGlobalNumDiags()==num_images) - TEST_ASSERT(A%getNodeNumDiags()==1) if (num_images > 2) then TEST_ASSERT(A%getGlobalMaxNumRowEntries()==3) else From 8e994abc057163aac775d765e73422bdc826f664 Mon Sep 17 00:00:00 2001 From: Seth R Johnson Date: Mon, 4 Feb 2019 11:40:28 -0500 Subject: [PATCH 22/40] Replace MatrixMarket wrappers with simpler class definition --- src/tpetra/src/Tpetra_InOut.i | 147 +- src/tpetra/src/swig/fortpetra.F90 | 1283 ++----------- src/tpetra/src/swig/fortpetraFORTRAN_wrap.cxx | 1646 +++-------------- 3 files changed, 516 insertions(+), 2560 deletions(-) diff --git a/src/tpetra/src/Tpetra_InOut.i b/src/tpetra/src/Tpetra_InOut.i index 0d3802d5..1da9f0d7 100644 --- a/src/tpetra/src/Tpetra_InOut.i +++ b/src/tpetra/src/Tpetra_InOut.i @@ -10,7 +10,6 @@ %import %{ -#include "Teuchos_RCP.hpp" #include "MatrixMarket_Tpetra.hpp" %} @@ -18,88 +17,78 @@ %apply LO { size_t getNumEntriesInLocalRow }; // ======================================================================= -// Ignore permanently +// Just declare a few methods +// (There are many overloads that we don't want) // ======================================================================= -%ignore Tpetra::MatrixMarket::Reader::readSparseGraph; -%ignore Tpetra::MatrixMarket::Reader::readSparse; -%ignore Tpetra::MatrixMarket::Reader::readDense; -%ignore Tpetra::MatrixMarket::Reader::readVector; -%ignore Tpetra::MatrixMarket::Reader::readMap; -%ignore Tpetra::MatrixMarket::Writer::writeSparse; -%ignore Tpetra::MatrixMarket::Writer::writeSparseGraph; -%ignore Tpetra::MatrixMarket::Writer::writeDense; -%ignore Tpetra::MatrixMarket::Writer::writeMap; -%ignore Tpetra::MatrixMarket::Writer::writeOperator; +namespace Tpetra { +namespace MatrixMarket { +template +class Reader { + public: + typedef SparseMatrixType sparse_matrix_type; -%inline %{ - typedef Tpetra::CrsMatrix CMT; -%} + typedef typename SparseMatrixType::scalar_type scalar_type; + typedef typename SparseMatrixType::local_ordinal_type local_ordinal_type; + typedef typename SparseMatrixType::global_ordinal_type global_ordinal_type; + typedef typename SparseMatrixType::node_type node_type; -// ======================================================================= -// Make interface more Fortran friendly -// ======================================================================= -%extend Tpetra::MatrixMarket::Reader { - static Teuchos::RCP < sparse_graph_type > readSparseGraphFile (const std::string& filename, const Teuchos::RCP< const Teuchos::Comm< int > > &pComm, const bool callFillComplete=true, const bool tolerant=false, const bool debug=false) { - return Tpetra::MatrixMarket::Reader::readSparseGraphFile(filename, pComm, callFillComplete, tolerant, debug); - } - static Teuchos::RCP < sparse_graph_type > readSparseGraphFile (const std::string& filename, const Teuchos::RCP< const Teuchos::Comm< int > > &pComm, const Teuchos::RCP< Teuchos::ParameterList > &constructorParams, const Teuchos::RCP< Teuchos::ParameterList > &fillCompleteParams, const bool tolerant=false, const bool debug=false) { - return Tpetra::MatrixMarket::Reader::readSparseGraphFile(filename, pComm, constructorParams, fillCompleteParams, tolerant, debug); - } - static Teuchos::RCP < sparse_graph_type > readSparseGraphFile (const std::string& filename, const Teuchos::RCP< const map_type > &rowMap, Teuchos::RCP< const map_type > &colMap, const Teuchos::RCP< const map_type > &domainMap, const Teuchos::RCP< const map_type > &rangeMap, const bool callFillComplete=true, const bool tolerant=false, const bool debug=false) { - return Tpetra::MatrixMarket::Reader::readSparseGraphFile(filename, rowMap, colMap, domainMap, rangeMap, callFillComplete, tolerant, debug); - } - static Teuchos::RCP < sparse_matrix_type > readSparseFile (const std::string& filename, const Teuchos::RCP< const Teuchos::Comm< int > > &pComm, const bool callFillComplete=true, const bool tolerant=false, const bool debug=false) { - return Tpetra::MatrixMarket::Reader::readSparseFile(filename, pComm, callFillComplete, tolerant, debug); - } - static Teuchos::RCP < sparse_matrix_type > readSparseFile (const std::string& filename, const Teuchos::RCP< const Teuchos::Comm< int > > &pComm, const Teuchos::RCP< Teuchos::ParameterList > &constructorParams, const Teuchos::RCP< Teuchos::ParameterList > &fillCompleteParams, const bool tolerant=false, const bool debug=false) { - return Tpetra::MatrixMarket::Reader::readSparseFile(filename, pComm, constructorParams, fillCompleteParams, tolerant, debug); - } - static Teuchos::RCP < sparse_matrix_type > readSparseFile (const std::string& filename, const Teuchos::RCP< const map_type > &rowMap, Teuchos::RCP< const map_type > &colMap, const Teuchos::RCP< const map_type > &domainMap, const Teuchos::RCP< const map_type > &rangeMap, const bool callFillComplete=true, const bool tolerant=false, const bool debug=false) { - return Tpetra::MatrixMarket::Reader::readSparseFile(filename, rowMap, colMap, domainMap, rangeMap, callFillComplete, tolerant, debug); - } - static Teuchos::RCP < multivector_type > readDenseFile (const std::string& filename, const Teuchos::RCP< const comm_type > &comm, Teuchos::RCP< const map_type > &map, const bool tolerant=false, const bool debug=false) { - return Tpetra::MatrixMarket::Reader::readDenseFile(filename, comm, map, tolerant, debug); - } - static Teuchos::RCP< const map_type > readMapFile (const std::string& filename, const Teuchos::RCP< const comm_type > &comm, const bool tolerant=false, const bool debug=false) { - return Tpetra::MatrixMarket::Reader::readMapFile(filename, comm, tolerant, debug); - } -} -%extend Tpetra::MatrixMarket::Writer { - static void writeSparseFile (const std::string& filename, const Teuchos::RCP< const sparse_matrix_type > &pMatrix, const std::string &matrixName, const std::string &matrixDescription, const bool debug=false) { - Tpetra::MatrixMarket::Writer::writeSparseFile(filename, pMatrix, matrixName, matrixDescription, debug); - } - static void writeSparseFile (const std::string& filename, const Teuchos::RCP< const sparse_matrix_type > &pMatrix, const bool debug=false) { - Tpetra::MatrixMarket::Writer::writeSparseFile(filename, pMatrix, debug); - } - static void writeSparseGraphFile (const std::string& filename, const Teuchos::RCP< const crs_graph_type > &pGraph, const std::string &graphName, const std::string &graphDescription, const bool debug=false) { - Tpetra::MatrixMarket::Writer::writeSparseGraphFile(filename, pGraph, graphName, graphDescription, debug); - } - static void writeSparseGraphFile (const std::string& filename, const Teuchos::RCP< const crs_graph_type > &pGraph, const bool debug=false) { - Tpetra::MatrixMarket::Writer::writeSparseGraphFile(filename, pGraph, debug); - } - static void writeDenseFile (const std::string &filename, const Teuchos::RCP< const multivector_type > &X, const std::string &matrixName, const std::string &matrixDescription) { - Tpetra::MatrixMarket::Writer::writeDenseFile(filename, X, matrixName, matrixDescription); - } - static void writeDenseFile (const std::string &filename, const Teuchos::RCP< const multivector_type > &X) { - Tpetra::MatrixMarket::Writer::writeDenseFile(filename, X); - } -} + typedef CrsGraph sparse_graph_type; + typedef MultiVector multivector_type; + typedef Teuchos::Comm comm_type; + typedef Map map_type; + + static Teuchos::RCP < sparse_graph_type > readSparseGraphFile (const std::string& filename, const Teuchos::RCP< const comm_type > &pComm, const bool callFillComplete=true); + static Teuchos::RCP < sparse_graph_type > readSparseGraphFile (const std::string& filename, const Teuchos::RCP< const comm_type > &pComm, const Teuchos::RCP< Teuchos::ParameterList > &constructorParams, const Teuchos::RCP< Teuchos::ParameterList > &fillCompleteParams); + static Teuchos::RCP < sparse_graph_type > readSparseGraphFile (const std::string& filename, const Teuchos::RCP< const map_type > &rowMap, Teuchos::RCP< const map_type > &colMap, const Teuchos::RCP< const map_type > &domainMap, const Teuchos::RCP< const map_type > &rangeMap, const bool callFillComplete=true); + static Teuchos::RCP < sparse_matrix_type > readSparseFile (const std::string& filename, const Teuchos::RCP< const comm_type > &pComm, const bool callFillComplete=true); + static Teuchos::RCP < sparse_matrix_type > readSparseFile (const std::string& filename, const Teuchos::RCP< const comm_type > &pComm, const Teuchos::RCP< Teuchos::ParameterList > &constructorParams, const Teuchos::RCP< Teuchos::ParameterList > &fillCompleteParams); + static Teuchos::RCP < sparse_matrix_type > readSparseFile (const std::string& filename, const Teuchos::RCP< const map_type > &rowMap, Teuchos::RCP< const map_type > &colMap, const Teuchos::RCP< const map_type > &domainMap, const Teuchos::RCP< const map_type > &rangeMap, const bool callFillComplete=true); + static Teuchos::RCP < multivector_type > readDenseFile (const std::string& filename, const Teuchos::RCP< const comm_type > &comm, Teuchos::RCP< const map_type > &map); + static Teuchos::RCP< const map_type > readMapFile (const std::string& filename, const Teuchos::RCP< const comm_type > &comm); + private: + Reader(); +}; + +template +class Writer { + public: + typedef SparseMatrixType sparse_matrix_type; + + typedef typename SparseMatrixType::scalar_type scalar_type; + typedef typename SparseMatrixType::local_ordinal_type local_ordinal_type; + typedef typename SparseMatrixType::global_ordinal_type global_ordinal_type; + typedef typename SparseMatrixType::node_type node_type; + + typedef CrsGraph crs_graph_type; + typedef MultiVector multivector_type; + typedef Teuchos::Comm comm_type; + typedef Map map_type; -%ignore Tpetra::MatrixMarket::Reader::readSparseGraphFile; -%ignore Tpetra::MatrixMarket::Reader::readSparseFile; -%ignore Tpetra::MatrixMarket::Reader::readDenseFile; -%ignore Tpetra::MatrixMarket::Reader::readVectorFile; -%ignore Tpetra::MatrixMarket::Reader::readMapFile; -%ignore Tpetra::MatrixMarket::Reader::readVectorVectorFile; -%ignore Tpetra::MatrixMarket::Writer::writeSparseFile; -%ignore Tpetra::MatrixMarket::Writer::writeSparseGraphFile; -%ignore Tpetra::MatrixMarket::Writer::writeDenseFile; -%ignore Tpetra::MatrixMarket::Writer::writeOperator; + static void writeSparseFile (const std::string& filename, const Teuchos::RCP< const sparse_matrix_type > &pMatrix, const std::string &matrixName, const std::string &matrixDescription); + static void writeSparseFile (const std::string& filename, const Teuchos::RCP< const sparse_matrix_type > &pMatrix); + static void writeSparseGraphFile (const std::string& filename, const Teuchos::RCP< const crs_graph_type > &pGraph, const std::string &graphName, const std::string &graphDescription); + static void writeSparseGraphFile (const std::string& filename, const Teuchos::RCP< const crs_graph_type > &pGraph); + static void writeDenseFile (const std::string &filename, const Teuchos::RCP< const multivector_type > &X, const std::string &matrixName, const std::string &matrixDescription); + static void writeDenseFile (const std::string &filename, const Teuchos::RCP< const multivector_type > &X); + private: + Writer(); +}; +} // namespace MatrixMarket +} // namespace Tpetra -%include "MatrixMarket_Tpetra.hpp" +%teuchos_rcp(Tpetra::MatrixMarket::Reader >) +%teuchos_rcp(Tpetra::MatrixMarket::Writer >) -%teuchos_rcp(Tpetra::MatrixMarket::Reader) -%teuchos_rcp(Tpetra::MatrixMarket::Writer) -%template(TpetraReader) Tpetra::MatrixMarket::Reader; -%template(TpetraWriter) Tpetra::MatrixMarket::Writer; +%template(TpetraReader) Tpetra::MatrixMarket::Reader >; +%template(TpetraWriter) Tpetra::MatrixMarket::Writer >; diff --git a/src/tpetra/src/swig/fortpetra.F90 b/src/tpetra/src/swig/fortpetra.F90 index c162c752..497fae75 100644 --- a/src/tpetra/src/swig/fortpetra.F90 +++ b/src/tpetra/src/swig/fortpetra.F90 @@ -599,7 +599,7 @@ module fortpetra end interface public :: operator_to_matrix public :: matrix_to_operator - ! class Tpetra::MatrixMarket::Reader< CMT > + ! class Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > > type, public :: TpetraReader type(SwigClassWrapper), public :: swigdata contains @@ -608,71 +608,38 @@ module fortpetra procedure, private, nopass :: readSparseGraphFile__SWIG_2 => TpetraReader_readSparseGraphFile__SWIG_2 procedure, private, nopass :: readSparseGraphFile__SWIG_3 => TpetraReader_readSparseGraphFile__SWIG_3 procedure, private, nopass :: readSparseGraphFile__SWIG_4 => TpetraReader_readSparseGraphFile__SWIG_4 - procedure, private, nopass :: readSparseGraphFile__SWIG_5 => TpetraReader_readSparseGraphFile__SWIG_5 - procedure, private, nopass :: readSparseGraphFile__SWIG_6 => TpetraReader_readSparseGraphFile__SWIG_6 - procedure, private, nopass :: readSparseGraphFile__SWIG_7 => TpetraReader_readSparseGraphFile__SWIG_7 - procedure, private, nopass :: readSparseGraphFile__SWIG_8 => TpetraReader_readSparseGraphFile__SWIG_8 - procedure, private, nopass :: readSparseGraphFile__SWIG_9 => TpetraReader_readSparseGraphFile__SWIG_9 - procedure, private, nopass :: readSparseGraphFile__SWIG_10 => TpetraReader_readSparseGraphFile__SWIG_10 procedure, private, nopass :: readSparseFile__SWIG_0 => TpetraReader_readSparseFile__SWIG_0 procedure, private, nopass :: readSparseFile__SWIG_1 => TpetraReader_readSparseFile__SWIG_1 procedure, private, nopass :: readSparseFile__SWIG_2 => TpetraReader_readSparseFile__SWIG_2 procedure, private, nopass :: readSparseFile__SWIG_3 => TpetraReader_readSparseFile__SWIG_3 procedure, private, nopass :: readSparseFile__SWIG_4 => TpetraReader_readSparseFile__SWIG_4 - procedure, private, nopass :: readSparseFile__SWIG_5 => TpetraReader_readSparseFile__SWIG_5 - procedure, private, nopass :: readSparseFile__SWIG_6 => TpetraReader_readSparseFile__SWIG_6 - procedure, private, nopass :: readSparseFile__SWIG_7 => TpetraReader_readSparseFile__SWIG_7 - procedure, private, nopass :: readSparseFile__SWIG_8 => TpetraReader_readSparseFile__SWIG_8 - procedure, private, nopass :: readSparseFile__SWIG_9 => TpetraReader_readSparseFile__SWIG_9 - procedure, private, nopass :: readSparseFile__SWIG_10 => TpetraReader_readSparseFile__SWIG_10 - procedure, private, nopass :: readDenseFile__SWIG_0 => TpetraReader_readDenseFile__SWIG_0 - procedure, private, nopass :: readDenseFile__SWIG_1 => TpetraReader_readDenseFile__SWIG_1 - procedure, private, nopass :: readDenseFile__SWIG_2 => TpetraReader_readDenseFile__SWIG_2 - procedure, private, nopass :: readMapFile__SWIG_0 => TpetraReader_readMapFile__SWIG_0 - procedure, private, nopass :: readMapFile__SWIG_1 => TpetraReader_readMapFile__SWIG_1 - procedure, private, nopass :: readMapFile__SWIG_2 => TpetraReader_readMapFile__SWIG_2 + procedure, nopass :: readDenseFile => TpetraReader_readDenseFile + procedure, nopass :: readMapFile => TpetraReader_readMapFile procedure :: release => delete_TpetraReader procedure, private :: swigf_assignment_TpetraReader generic :: assignment(=) => swigf_assignment_TpetraReader generic :: readSparseGraphFile => readSparseGraphFile__SWIG_0, readSparseGraphFile__SWIG_1, readSparseGraphFile__SWIG_2, & - readSparseGraphFile__SWIG_3, readSparseGraphFile__SWIG_4, readSparseGraphFile__SWIG_5, readSparseGraphFile__SWIG_6, & - readSparseGraphFile__SWIG_7, readSparseGraphFile__SWIG_8, readSparseGraphFile__SWIG_9, readSparseGraphFile__SWIG_10 + readSparseGraphFile__SWIG_3, readSparseGraphFile__SWIG_4 generic :: readSparseFile => readSparseFile__SWIG_0, readSparseFile__SWIG_1, readSparseFile__SWIG_2, readSparseFile__SWIG_3, & - readSparseFile__SWIG_4, readSparseFile__SWIG_5, readSparseFile__SWIG_6, readSparseFile__SWIG_7, readSparseFile__SWIG_8, & - readSparseFile__SWIG_9, readSparseFile__SWIG_10 - generic :: readDenseFile => readDenseFile__SWIG_0, readDenseFile__SWIG_1, readDenseFile__SWIG_2 - generic :: readMapFile => readMapFile__SWIG_0, readMapFile__SWIG_1, readMapFile__SWIG_2 + readSparseFile__SWIG_4 end type TpetraReader - interface TpetraReader - module procedure new_TpetraReader - end interface - ! class Tpetra::MatrixMarket::Writer< CMT > + ! class Tpetra::MatrixMarket::Writer< Tpetra::CrsMatrix< SC,LO,GO,NO > > type, public :: TpetraWriter type(SwigClassWrapper), public :: swigdata contains - procedure, nopass :: writeMapFile => TpetraWriter_writeMapFile procedure, private, nopass :: writeSparseFile__SWIG_0 => TpetraWriter_writeSparseFile__SWIG_0 procedure, private, nopass :: writeSparseFile__SWIG_1 => TpetraWriter_writeSparseFile__SWIG_1 - procedure, private, nopass :: writeSparseFile__SWIG_2 => TpetraWriter_writeSparseFile__SWIG_2 - procedure, private, nopass :: writeSparseFile__SWIG_3 => TpetraWriter_writeSparseFile__SWIG_3 procedure, private, nopass :: writeSparseGraphFile__SWIG_0 => TpetraWriter_writeSparseGraphFile__SWIG_0 procedure, private, nopass :: writeSparseGraphFile__SWIG_1 => TpetraWriter_writeSparseGraphFile__SWIG_1 - procedure, private, nopass :: writeSparseGraphFile__SWIG_2 => TpetraWriter_writeSparseGraphFile__SWIG_2 - procedure, private, nopass :: writeSparseGraphFile__SWIG_3 => TpetraWriter_writeSparseGraphFile__SWIG_3 procedure, private, nopass :: writeDenseFile__SWIG_0 => TpetraWriter_writeDenseFile__SWIG_0 procedure, private, nopass :: writeDenseFile__SWIG_1 => TpetraWriter_writeDenseFile__SWIG_1 procedure :: release => delete_TpetraWriter procedure, private :: swigf_assignment_TpetraWriter generic :: assignment(=) => swigf_assignment_TpetraWriter - generic :: writeSparseGraphFile => writeSparseGraphFile__SWIG_0, writeSparseGraphFile__SWIG_1, writeSparseGraphFile__SWIG_2, & - writeSparseGraphFile__SWIG_3 - generic :: writeSparseFile => writeSparseFile__SWIG_0, writeSparseFile__SWIG_1, writeSparseFile__SWIG_2, & - writeSparseFile__SWIG_3 + generic :: writeSparseGraphFile => writeSparseGraphFile__SWIG_0, writeSparseGraphFile__SWIG_1 + generic :: writeSparseFile => writeSparseFile__SWIG_0, writeSparseFile__SWIG_1 generic :: writeDenseFile => writeDenseFile__SWIG_0, writeDenseFile__SWIG_1 end type TpetraWriter - interface TpetraWriter - module procedure new_TpetraWriter - end interface interface TpetraMatrixMatrixAdd module procedure TpetraMatrixMatrixAdd__SWIG_0, TpetraMatrixMatrixAdd__SWIG_1 end interface @@ -4041,7 +4008,7 @@ function swigc_matrix_to_operator(farg1) & type(SwigClassWrapper) :: fresult end function -function swigc_TpetraReader_readSparseGraphFile__SWIG_0(farg1, farg2, farg3, farg4, farg5) & +function swigc_TpetraReader_readSparseGraphFile__SWIG_0(farg1, farg2, farg3) & bind(C, name="_wrap_TpetraReader_readSparseGraphFile__SWIG_0") & result(fresult) use, intrinsic :: ISO_C_BINDING @@ -4050,12 +4017,10 @@ function swigc_TpetraReader_readSparseGraphFile__SWIG_0(farg1, farg2, farg3, far type(SwigArrayWrapper) :: farg1 type(SwigClassWrapper) :: farg2 integer(C_INT), intent(in) :: farg3 -integer(C_INT), intent(in) :: farg4 -integer(C_INT), intent(in) :: farg5 type(SwigClassWrapper) :: fresult end function -function swigc_TpetraReader_readSparseGraphFile__SWIG_1(farg1, farg2, farg3, farg4) & +function swigc_TpetraReader_readSparseGraphFile__SWIG_1(farg1, farg2) & bind(C, name="_wrap_TpetraReader_readSparseGraphFile__SWIG_1") & result(fresult) use, intrinsic :: ISO_C_BINDING @@ -4063,12 +4028,10 @@ function swigc_TpetraReader_readSparseGraphFile__SWIG_1(farg1, farg2, farg3, far import :: swigarraywrapper type(SwigArrayWrapper) :: farg1 type(SwigClassWrapper) :: farg2 -integer(C_INT), intent(in) :: farg3 -integer(C_INT), intent(in) :: farg4 type(SwigClassWrapper) :: fresult end function -function swigc_TpetraReader_readSparseGraphFile__SWIG_2(farg1, farg2, farg3) & +function swigc_TpetraReader_readSparseGraphFile__SWIG_2(farg1, farg2, farg3, farg4) & bind(C, name="_wrap_TpetraReader_readSparseGraphFile__SWIG_2") & result(fresult) use, intrinsic :: ISO_C_BINDING @@ -4076,98 +4039,13 @@ function swigc_TpetraReader_readSparseGraphFile__SWIG_2(farg1, farg2, farg3) & import :: swigarraywrapper type(SwigArrayWrapper) :: farg1 type(SwigClassWrapper) :: farg2 -integer(C_INT), intent(in) :: farg3 -type(SwigClassWrapper) :: fresult -end function - -function swigc_TpetraReader_readSparseGraphFile__SWIG_3(farg1, farg2) & -bind(C, name="_wrap_TpetraReader_readSparseGraphFile__SWIG_3") & -result(fresult) -use, intrinsic :: ISO_C_BINDING -import :: swigclasswrapper -import :: swigarraywrapper -type(SwigArrayWrapper) :: farg1 -type(SwigClassWrapper) :: farg2 -type(SwigClassWrapper) :: fresult -end function - -function swigc_TpetraReader_readSparseGraphFile__SWIG_4(farg1, farg2, farg3, farg4, farg5, farg6) & -bind(C, name="_wrap_TpetraReader_readSparseGraphFile__SWIG_4") & -result(fresult) -use, intrinsic :: ISO_C_BINDING -import :: swigclasswrapper -import :: swigarraywrapper -type(SwigArrayWrapper) :: farg1 -type(SwigClassWrapper) :: farg2 -type(SwigClassWrapper) :: farg3 -type(SwigClassWrapper) :: farg4 -integer(C_INT), intent(in) :: farg5 -integer(C_INT), intent(in) :: farg6 -type(SwigClassWrapper) :: fresult -end function - -function swigc_TpetraReader_readSparseGraphFile__SWIG_5(farg1, farg2, farg3, farg4, farg5) & -bind(C, name="_wrap_TpetraReader_readSparseGraphFile__SWIG_5") & -result(fresult) -use, intrinsic :: ISO_C_BINDING -import :: swigclasswrapper -import :: swigarraywrapper -type(SwigArrayWrapper) :: farg1 -type(SwigClassWrapper) :: farg2 -type(SwigClassWrapper) :: farg3 -type(SwigClassWrapper) :: farg4 -integer(C_INT), intent(in) :: farg5 -type(SwigClassWrapper) :: fresult -end function - -function swigc_TpetraReader_readSparseGraphFile__SWIG_6(farg1, farg2, farg3, farg4) & -bind(C, name="_wrap_TpetraReader_readSparseGraphFile__SWIG_6") & -result(fresult) -use, intrinsic :: ISO_C_BINDING -import :: swigclasswrapper -import :: swigarraywrapper -type(SwigArrayWrapper) :: farg1 -type(SwigClassWrapper) :: farg2 -type(SwigClassWrapper) :: farg3 -type(SwigClassWrapper) :: farg4 -type(SwigClassWrapper) :: fresult -end function - -function swigc_TpetraReader_readSparseGraphFile__SWIG_7(farg1, farg2, farg3, farg4, farg5, farg6, farg7, farg8) & -bind(C, name="_wrap_TpetraReader_readSparseGraphFile__SWIG_7") & -result(fresult) -use, intrinsic :: ISO_C_BINDING -import :: swigclasswrapper -import :: swigarraywrapper -type(SwigArrayWrapper) :: farg1 -type(SwigClassWrapper) :: farg2 -type(SwigClassWrapper) :: farg3 -type(SwigClassWrapper) :: farg4 -type(SwigClassWrapper) :: farg5 -integer(C_INT), intent(in) :: farg6 -integer(C_INT), intent(in) :: farg7 -integer(C_INT), intent(in) :: farg8 -type(SwigClassWrapper) :: fresult -end function - -function swigc_TpetraReader_readSparseGraphFile__SWIG_8(farg1, farg2, farg3, farg4, farg5, farg6, farg7) & -bind(C, name="_wrap_TpetraReader_readSparseGraphFile__SWIG_8") & -result(fresult) -use, intrinsic :: ISO_C_BINDING -import :: swigclasswrapper -import :: swigarraywrapper -type(SwigArrayWrapper) :: farg1 -type(SwigClassWrapper) :: farg2 type(SwigClassWrapper) :: farg3 type(SwigClassWrapper) :: farg4 -type(SwigClassWrapper) :: farg5 -integer(C_INT), intent(in) :: farg6 -integer(C_INT), intent(in) :: farg7 type(SwigClassWrapper) :: fresult end function -function swigc_TpetraReader_readSparseGraphFile__SWIG_9(farg1, farg2, farg3, farg4, farg5, farg6) & -bind(C, name="_wrap_TpetraReader_readSparseGraphFile__SWIG_9") & +function swigc_TpetraReader_readSparseGraphFile__SWIG_3(farg1, farg2, farg3, farg4, farg5, farg6) & +bind(C, name="_wrap_TpetraReader_readSparseGraphFile__SWIG_3") & result(fresult) use, intrinsic :: ISO_C_BINDING import :: swigclasswrapper @@ -4181,8 +4059,8 @@ function swigc_TpetraReader_readSparseGraphFile__SWIG_9(farg1, farg2, farg3, far type(SwigClassWrapper) :: fresult end function -function swigc_TpetraReader_readSparseGraphFile__SWIG_10(farg1, farg2, farg3, farg4, farg5) & -bind(C, name="_wrap_TpetraReader_readSparseGraphFile__SWIG_10") & +function swigc_TpetraReader_readSparseGraphFile__SWIG_4(farg1, farg2, farg3, farg4, farg5) & +bind(C, name="_wrap_TpetraReader_readSparseGraphFile__SWIG_4") & result(fresult) use, intrinsic :: ISO_C_BINDING import :: swigclasswrapper @@ -4195,7 +4073,7 @@ function swigc_TpetraReader_readSparseGraphFile__SWIG_10(farg1, farg2, farg3, fa type(SwigClassWrapper) :: fresult end function -function swigc_TpetraReader_readSparseFile__SWIG_0(farg1, farg2, farg3, farg4, farg5) & +function swigc_TpetraReader_readSparseFile__SWIG_0(farg1, farg2, farg3) & bind(C, name="_wrap_TpetraReader_readSparseFile__SWIG_0") & result(fresult) use, intrinsic :: ISO_C_BINDING @@ -4204,12 +4082,10 @@ function swigc_TpetraReader_readSparseFile__SWIG_0(farg1, farg2, farg3, farg4, f type(SwigArrayWrapper) :: farg1 type(SwigClassWrapper) :: farg2 integer(C_INT), intent(in) :: farg3 -integer(C_INT), intent(in) :: farg4 -integer(C_INT), intent(in) :: farg5 type(SwigClassWrapper) :: fresult end function -function swigc_TpetraReader_readSparseFile__SWIG_1(farg1, farg2, farg3, farg4) & +function swigc_TpetraReader_readSparseFile__SWIG_1(farg1, farg2) & bind(C, name="_wrap_TpetraReader_readSparseFile__SWIG_1") & result(fresult) use, intrinsic :: ISO_C_BINDING @@ -4217,12 +4093,10 @@ function swigc_TpetraReader_readSparseFile__SWIG_1(farg1, farg2, farg3, farg4) & import :: swigarraywrapper type(SwigArrayWrapper) :: farg1 type(SwigClassWrapper) :: farg2 -integer(C_INT), intent(in) :: farg3 -integer(C_INT), intent(in) :: farg4 type(SwigClassWrapper) :: fresult end function -function swigc_TpetraReader_readSparseFile__SWIG_2(farg1, farg2, farg3) & +function swigc_TpetraReader_readSparseFile__SWIG_2(farg1, farg2, farg3, farg4) & bind(C, name="_wrap_TpetraReader_readSparseFile__SWIG_2") & result(fresult) use, intrinsic :: ISO_C_BINDING @@ -4230,98 +4104,13 @@ function swigc_TpetraReader_readSparseFile__SWIG_2(farg1, farg2, farg3) & import :: swigarraywrapper type(SwigArrayWrapper) :: farg1 type(SwigClassWrapper) :: farg2 -integer(C_INT), intent(in) :: farg3 -type(SwigClassWrapper) :: fresult -end function - -function swigc_TpetraReader_readSparseFile__SWIG_3(farg1, farg2) & -bind(C, name="_wrap_TpetraReader_readSparseFile__SWIG_3") & -result(fresult) -use, intrinsic :: ISO_C_BINDING -import :: swigclasswrapper -import :: swigarraywrapper -type(SwigArrayWrapper) :: farg1 -type(SwigClassWrapper) :: farg2 -type(SwigClassWrapper) :: fresult -end function - -function swigc_TpetraReader_readSparseFile__SWIG_4(farg1, farg2, farg3, farg4, farg5, farg6) & -bind(C, name="_wrap_TpetraReader_readSparseFile__SWIG_4") & -result(fresult) -use, intrinsic :: ISO_C_BINDING -import :: swigclasswrapper -import :: swigarraywrapper -type(SwigArrayWrapper) :: farg1 -type(SwigClassWrapper) :: farg2 -type(SwigClassWrapper) :: farg3 -type(SwigClassWrapper) :: farg4 -integer(C_INT), intent(in) :: farg5 -integer(C_INT), intent(in) :: farg6 -type(SwigClassWrapper) :: fresult -end function - -function swigc_TpetraReader_readSparseFile__SWIG_5(farg1, farg2, farg3, farg4, farg5) & -bind(C, name="_wrap_TpetraReader_readSparseFile__SWIG_5") & -result(fresult) -use, intrinsic :: ISO_C_BINDING -import :: swigclasswrapper -import :: swigarraywrapper -type(SwigArrayWrapper) :: farg1 -type(SwigClassWrapper) :: farg2 -type(SwigClassWrapper) :: farg3 -type(SwigClassWrapper) :: farg4 -integer(C_INT), intent(in) :: farg5 -type(SwigClassWrapper) :: fresult -end function - -function swigc_TpetraReader_readSparseFile__SWIG_6(farg1, farg2, farg3, farg4) & -bind(C, name="_wrap_TpetraReader_readSparseFile__SWIG_6") & -result(fresult) -use, intrinsic :: ISO_C_BINDING -import :: swigclasswrapper -import :: swigarraywrapper -type(SwigArrayWrapper) :: farg1 -type(SwigClassWrapper) :: farg2 -type(SwigClassWrapper) :: farg3 -type(SwigClassWrapper) :: farg4 -type(SwigClassWrapper) :: fresult -end function - -function swigc_TpetraReader_readSparseFile__SWIG_7(farg1, farg2, farg3, farg4, farg5, farg6, farg7, farg8) & -bind(C, name="_wrap_TpetraReader_readSparseFile__SWIG_7") & -result(fresult) -use, intrinsic :: ISO_C_BINDING -import :: swigclasswrapper -import :: swigarraywrapper -type(SwigArrayWrapper) :: farg1 -type(SwigClassWrapper) :: farg2 type(SwigClassWrapper) :: farg3 type(SwigClassWrapper) :: farg4 -type(SwigClassWrapper) :: farg5 -integer(C_INT), intent(in) :: farg6 -integer(C_INT), intent(in) :: farg7 -integer(C_INT), intent(in) :: farg8 -type(SwigClassWrapper) :: fresult -end function - -function swigc_TpetraReader_readSparseFile__SWIG_8(farg1, farg2, farg3, farg4, farg5, farg6, farg7) & -bind(C, name="_wrap_TpetraReader_readSparseFile__SWIG_8") & -result(fresult) -use, intrinsic :: ISO_C_BINDING -import :: swigclasswrapper -import :: swigarraywrapper -type(SwigArrayWrapper) :: farg1 -type(SwigClassWrapper) :: farg2 -type(SwigClassWrapper) :: farg3 -type(SwigClassWrapper) :: farg4 -type(SwigClassWrapper) :: farg5 -integer(C_INT), intent(in) :: farg6 -integer(C_INT), intent(in) :: farg7 type(SwigClassWrapper) :: fresult end function -function swigc_TpetraReader_readSparseFile__SWIG_9(farg1, farg2, farg3, farg4, farg5, farg6) & -bind(C, name="_wrap_TpetraReader_readSparseFile__SWIG_9") & +function swigc_TpetraReader_readSparseFile__SWIG_3(farg1, farg2, farg3, farg4, farg5, farg6) & +bind(C, name="_wrap_TpetraReader_readSparseFile__SWIG_3") & result(fresult) use, intrinsic :: ISO_C_BINDING import :: swigclasswrapper @@ -4335,8 +4124,8 @@ function swigc_TpetraReader_readSparseFile__SWIG_9(farg1, farg2, farg3, farg4, f type(SwigClassWrapper) :: fresult end function -function swigc_TpetraReader_readSparseFile__SWIG_10(farg1, farg2, farg3, farg4, farg5) & -bind(C, name="_wrap_TpetraReader_readSparseFile__SWIG_10") & +function swigc_TpetraReader_readSparseFile__SWIG_4(farg1, farg2, farg3, farg4, farg5) & +bind(C, name="_wrap_TpetraReader_readSparseFile__SWIG_4") & result(fresult) use, intrinsic :: ISO_C_BINDING import :: swigclasswrapper @@ -4349,22 +4138,8 @@ function swigc_TpetraReader_readSparseFile__SWIG_10(farg1, farg2, farg3, farg4, type(SwigClassWrapper) :: fresult end function -function swigc_TpetraReader_readDenseFile__SWIG_0(farg1, farg2, farg3, farg4, farg5) & -bind(C, name="_wrap_TpetraReader_readDenseFile__SWIG_0") & -result(fresult) -use, intrinsic :: ISO_C_BINDING -import :: swigclasswrapper -import :: swigarraywrapper -type(SwigArrayWrapper) :: farg1 -type(SwigClassWrapper) :: farg2 -type(SwigClassWrapper) :: farg3 -integer(C_INT), intent(in) :: farg4 -integer(C_INT), intent(in) :: farg5 -type(SwigClassWrapper) :: fresult -end function - -function swigc_TpetraReader_readDenseFile__SWIG_1(farg1, farg2, farg3, farg4) & -bind(C, name="_wrap_TpetraReader_readDenseFile__SWIG_1") & +function swigc_TpetraReader_readDenseFile(farg1, farg2, farg3) & +bind(C, name="_wrap_TpetraReader_readDenseFile") & result(fresult) use, intrinsic :: ISO_C_BINDING import :: swigclasswrapper @@ -4372,49 +4147,11 @@ function swigc_TpetraReader_readDenseFile__SWIG_1(farg1, farg2, farg3, farg4) & type(SwigArrayWrapper) :: farg1 type(SwigClassWrapper) :: farg2 type(SwigClassWrapper) :: farg3 -integer(C_INT), intent(in) :: farg4 -type(SwigClassWrapper) :: fresult -end function - -function swigc_TpetraReader_readDenseFile__SWIG_2(farg1, farg2, farg3) & -bind(C, name="_wrap_TpetraReader_readDenseFile__SWIG_2") & -result(fresult) -use, intrinsic :: ISO_C_BINDING -import :: swigclasswrapper -import :: swigarraywrapper -type(SwigArrayWrapper) :: farg1 -type(SwigClassWrapper) :: farg2 -type(SwigClassWrapper) :: farg3 -type(SwigClassWrapper) :: fresult -end function - -function swigc_TpetraReader_readMapFile__SWIG_0(farg1, farg2, farg3, farg4) & -bind(C, name="_wrap_TpetraReader_readMapFile__SWIG_0") & -result(fresult) -use, intrinsic :: ISO_C_BINDING -import :: swigclasswrapper -import :: swigarraywrapper -type(SwigArrayWrapper) :: farg1 -type(SwigClassWrapper) :: farg2 -integer(C_INT), intent(in) :: farg3 -integer(C_INT), intent(in) :: farg4 -type(SwigClassWrapper) :: fresult -end function - -function swigc_TpetraReader_readMapFile__SWIG_1(farg1, farg2, farg3) & -bind(C, name="_wrap_TpetraReader_readMapFile__SWIG_1") & -result(fresult) -use, intrinsic :: ISO_C_BINDING -import :: swigclasswrapper -import :: swigarraywrapper -type(SwigArrayWrapper) :: farg1 -type(SwigClassWrapper) :: farg2 -integer(C_INT), intent(in) :: farg3 type(SwigClassWrapper) :: fresult end function -function swigc_TpetraReader_readMapFile__SWIG_2(farg1, farg2) & -bind(C, name="_wrap_TpetraReader_readMapFile__SWIG_2") & +function swigc_TpetraReader_readMapFile(farg1, farg2) & +bind(C, name="_wrap_TpetraReader_readMapFile") & result(fresult) use, intrinsic :: ISO_C_BINDING import :: swigclasswrapper @@ -4424,14 +4161,6 @@ function swigc_TpetraReader_readMapFile__SWIG_2(farg1, farg2) & type(SwigClassWrapper) :: fresult end function -function swigc_new_TpetraReader() & -bind(C, name="_wrap_new_TpetraReader") & -result(fresult) -use, intrinsic :: ISO_C_BINDING -import :: swigclasswrapper -type(SwigClassWrapper) :: fresult -end function - subroutine swigc_delete_TpetraReader(farg1) & bind(C, name="_wrap_delete_TpetraReader") use, intrinsic :: ISO_C_BINDING @@ -4446,16 +4175,7 @@ subroutine swigc_assignment_TpetraReader(self, other) & type(SwigClassWrapper), intent(inout) :: self type(SwigClassWrapper), intent(in) :: other end subroutine -subroutine swigc_TpetraWriter_writeMapFile(farg1, farg2) & -bind(C, name="_wrap_TpetraWriter_writeMapFile") -use, intrinsic :: ISO_C_BINDING -import :: swigarraywrapper -import :: swigclasswrapper -type(SwigArrayWrapper) :: farg1 -type(SwigClassWrapper) :: farg2 -end subroutine - -subroutine swigc_TpetraWriter_writeSparseFile__SWIG_0(farg1, farg2, farg3, farg4, farg5) & +subroutine swigc_TpetraWriter_writeSparseFile__SWIG_0(farg1, farg2, farg3, farg4) & bind(C, name="_wrap_TpetraWriter_writeSparseFile__SWIG_0") use, intrinsic :: ISO_C_BINDING import :: swigarraywrapper @@ -4464,32 +4184,30 @@ subroutine swigc_TpetraWriter_writeSparseFile__SWIG_0(farg1, farg2, farg3, farg4 type(SwigClassWrapper) :: farg2 type(SwigArrayWrapper) :: farg3 type(SwigArrayWrapper) :: farg4 -integer(C_INT), intent(in) :: farg5 end subroutine -subroutine swigc_TpetraWriter_writeSparseFile__SWIG_1(farg1, farg2, farg3, farg4) & +subroutine swigc_TpetraWriter_writeSparseFile__SWIG_1(farg1, farg2) & bind(C, name="_wrap_TpetraWriter_writeSparseFile__SWIG_1") use, intrinsic :: ISO_C_BINDING import :: swigarraywrapper import :: swigclasswrapper type(SwigArrayWrapper) :: farg1 type(SwigClassWrapper) :: farg2 -type(SwigArrayWrapper) :: farg3 -type(SwigArrayWrapper) :: farg4 end subroutine -subroutine swigc_TpetraWriter_writeSparseFile__SWIG_2(farg1, farg2, farg3) & -bind(C, name="_wrap_TpetraWriter_writeSparseFile__SWIG_2") +subroutine swigc_TpetraWriter_writeSparseGraphFile__SWIG_0(farg1, farg2, farg3, farg4) & +bind(C, name="_wrap_TpetraWriter_writeSparseGraphFile__SWIG_0") use, intrinsic :: ISO_C_BINDING import :: swigarraywrapper import :: swigclasswrapper type(SwigArrayWrapper) :: farg1 type(SwigClassWrapper) :: farg2 -integer(C_INT), intent(in) :: farg3 +type(SwigArrayWrapper) :: farg3 +type(SwigArrayWrapper) :: farg4 end subroutine -subroutine swigc_TpetraWriter_writeSparseFile__SWIG_3(farg1, farg2) & -bind(C, name="_wrap_TpetraWriter_writeSparseFile__SWIG_3") +subroutine swigc_TpetraWriter_writeSparseGraphFile__SWIG_1(farg1, farg2) & +bind(C, name="_wrap_TpetraWriter_writeSparseGraphFile__SWIG_1") use, intrinsic :: ISO_C_BINDING import :: swigarraywrapper import :: swigclasswrapper @@ -4497,8 +4215,8 @@ subroutine swigc_TpetraWriter_writeSparseFile__SWIG_3(farg1, farg2) & type(SwigClassWrapper) :: farg2 end subroutine -subroutine swigc_TpetraWriter_writeSparseGraphFile__SWIG_0(farg1, farg2, farg3, farg4, farg5) & -bind(C, name="_wrap_TpetraWriter_writeSparseGraphFile__SWIG_0") +subroutine swigc_TpetraWriter_writeDenseFile__SWIG_0(farg1, farg2, farg3, farg4) & +bind(C, name="_wrap_TpetraWriter_writeDenseFile__SWIG_0") use, intrinsic :: ISO_C_BINDING import :: swigarraywrapper import :: swigclasswrapper @@ -4506,83 +4224,33 @@ subroutine swigc_TpetraWriter_writeSparseGraphFile__SWIG_0(farg1, farg2, farg3, type(SwigClassWrapper) :: farg2 type(SwigArrayWrapper) :: farg3 type(SwigArrayWrapper) :: farg4 -integer(C_INT), intent(in) :: farg5 end subroutine -subroutine swigc_TpetraWriter_writeSparseGraphFile__SWIG_1(farg1, farg2, farg3, farg4) & -bind(C, name="_wrap_TpetraWriter_writeSparseGraphFile__SWIG_1") +subroutine swigc_TpetraWriter_writeDenseFile__SWIG_1(farg1, farg2) & +bind(C, name="_wrap_TpetraWriter_writeDenseFile__SWIG_1") use, intrinsic :: ISO_C_BINDING import :: swigarraywrapper import :: swigclasswrapper type(SwigArrayWrapper) :: farg1 type(SwigClassWrapper) :: farg2 -type(SwigArrayWrapper) :: farg3 -type(SwigArrayWrapper) :: farg4 end subroutine -subroutine swigc_TpetraWriter_writeSparseGraphFile__SWIG_2(farg1, farg2, farg3) & -bind(C, name="_wrap_TpetraWriter_writeSparseGraphFile__SWIG_2") +subroutine swigc_delete_TpetraWriter(farg1) & +bind(C, name="_wrap_delete_TpetraWriter") use, intrinsic :: ISO_C_BINDING -import :: swigarraywrapper import :: swigclasswrapper -type(SwigArrayWrapper) :: farg1 -type(SwigClassWrapper) :: farg2 -integer(C_INT), intent(in) :: farg3 +type(SwigClassWrapper) :: farg1 end subroutine -subroutine swigc_TpetraWriter_writeSparseGraphFile__SWIG_3(farg1, farg2) & -bind(C, name="_wrap_TpetraWriter_writeSparseGraphFile__SWIG_3") -use, intrinsic :: ISO_C_BINDING -import :: swigarraywrapper -import :: swigclasswrapper -type(SwigArrayWrapper) :: farg1 -type(SwigClassWrapper) :: farg2 -end subroutine - -subroutine swigc_TpetraWriter_writeDenseFile__SWIG_0(farg1, farg2, farg3, farg4) & -bind(C, name="_wrap_TpetraWriter_writeDenseFile__SWIG_0") -use, intrinsic :: ISO_C_BINDING -import :: swigarraywrapper -import :: swigclasswrapper -type(SwigArrayWrapper) :: farg1 -type(SwigClassWrapper) :: farg2 -type(SwigArrayWrapper) :: farg3 -type(SwigArrayWrapper) :: farg4 -end subroutine - -subroutine swigc_TpetraWriter_writeDenseFile__SWIG_1(farg1, farg2) & -bind(C, name="_wrap_TpetraWriter_writeDenseFile__SWIG_1") -use, intrinsic :: ISO_C_BINDING -import :: swigarraywrapper -import :: swigclasswrapper -type(SwigArrayWrapper) :: farg1 -type(SwigClassWrapper) :: farg2 -end subroutine - -function swigc_new_TpetraWriter() & -bind(C, name="_wrap_new_TpetraWriter") & -result(fresult) -use, intrinsic :: ISO_C_BINDING -import :: swigclasswrapper -type(SwigClassWrapper) :: fresult -end function - -subroutine swigc_delete_TpetraWriter(farg1) & -bind(C, name="_wrap_delete_TpetraWriter") -use, intrinsic :: ISO_C_BINDING -import :: swigclasswrapper -type(SwigClassWrapper) :: farg1 -end subroutine - - subroutine swigc_assignment_TpetraWriter(self, other) & - bind(C, name="_wrap_assign_TpetraWriter") - use, intrinsic :: ISO_C_BINDING - import :: SwigClassWrapper - type(SwigClassWrapper), intent(inout) :: self - type(SwigClassWrapper), intent(in) :: other - end subroutine -subroutine swigc_TpetraMatrixMatrixMultiply__SWIG_0(farg1, farg2, farg3, farg4, farg5, farg6, farg7, farg8) & -bind(C, name="_wrap_TpetraMatrixMatrixMultiply__SWIG_0") + subroutine swigc_assignment_TpetraWriter(self, other) & + bind(C, name="_wrap_assign_TpetraWriter") + use, intrinsic :: ISO_C_BINDING + import :: SwigClassWrapper + type(SwigClassWrapper), intent(inout) :: self + type(SwigClassWrapper), intent(in) :: other + end subroutine +subroutine swigc_TpetraMatrixMatrixMultiply__SWIG_0(farg1, farg2, farg3, farg4, farg5, farg6, farg7, farg8) & +bind(C, name="_wrap_TpetraMatrixMatrixMultiply__SWIG_0") use, intrinsic :: ISO_C_BINDING import :: swigclasswrapper import :: swigarraywrapper @@ -11057,7 +10725,7 @@ function matrix_to_operator(a) & swig_result%swigdata = fresult end function -function TpetraReader_readSparseGraphFile__SWIG_0(filename, pcomm, callfillcomplete, tolerant, debug) & +function TpetraReader_readSparseGraphFile__SWIG_0(filename, pcomm, callfillcomplete) & result(swig_result) use, intrinsic :: ISO_C_BINDING type(TpetraCrsGraph) :: swig_result @@ -11066,26 +10734,20 @@ function TpetraReader_readSparseGraphFile__SWIG_0(filename, pcomm, callfillcompl class(TeuchosComm), intent(in) :: pcomm logical, intent(in) :: callfillcomplete -logical, intent(in) :: tolerant -logical, intent(in) :: debug type(SwigClassWrapper) :: fresult type(SwigArrayWrapper) :: farg1 type(SwigClassWrapper) :: farg2 integer(C_INT) :: farg3 -integer(C_INT) :: farg4 -integer(C_INT) :: farg5 call SWIG_string_to_chararray(filename, farg1_chars, farg1) farg2 = pcomm%swigdata farg3 = SWIG_logical_to_int(callfillcomplete) -farg4 = SWIG_logical_to_int(tolerant) -farg5 = SWIG_logical_to_int(debug) -fresult = swigc_TpetraReader_readSparseGraphFile__SWIG_0(farg1, farg2, farg3, farg4, farg5) +fresult = swigc_TpetraReader_readSparseGraphFile__SWIG_0(farg1, farg2, farg3) swig_result%swigdata = fresult end function -function TpetraReader_readSparseGraphFile__SWIG_1(filename, pcomm, callfillcomplete, tolerant) & +function TpetraReader_readSparseGraphFile__SWIG_1(filename, pcomm) & result(swig_result) use, intrinsic :: ISO_C_BINDING type(TpetraCrsGraph) :: swig_result @@ -11093,24 +10755,17 @@ function TpetraReader_readSparseGraphFile__SWIG_1(filename, pcomm, callfillcompl character(kind=C_CHAR), dimension(:), allocatable, target :: farg1_chars class(TeuchosComm), intent(in) :: pcomm -logical, intent(in) :: callfillcomplete -logical, intent(in) :: tolerant - type(SwigClassWrapper) :: fresult type(SwigArrayWrapper) :: farg1 type(SwigClassWrapper) :: farg2 -integer(C_INT) :: farg3 -integer(C_INT) :: farg4 call SWIG_string_to_chararray(filename, farg1_chars, farg1) farg2 = pcomm%swigdata -farg3 = SWIG_logical_to_int(callfillcomplete) -farg4 = SWIG_logical_to_int(tolerant) -fresult = swigc_TpetraReader_readSparseGraphFile__SWIG_1(farg1, farg2, farg3, farg4) +fresult = swigc_TpetraReader_readSparseGraphFile__SWIG_1(farg1, farg2) swig_result%swigdata = fresult end function -function TpetraReader_readSparseGraphFile__SWIG_2(filename, pcomm, callfillcomplete) & +function TpetraReader_readSparseGraphFile__SWIG_2(filename, pcomm, constructorparams, fillcompleteparams) & result(swig_result) use, intrinsic :: ISO_C_BINDING type(TpetraCrsGraph) :: swig_result @@ -11118,209 +10773,158 @@ function TpetraReader_readSparseGraphFile__SWIG_2(filename, pcomm, callfillcompl character(kind=C_CHAR), dimension(:), allocatable, target :: farg1_chars class(TeuchosComm), intent(in) :: pcomm -logical, intent(in) :: callfillcomplete - -type(SwigClassWrapper) :: fresult -type(SwigArrayWrapper) :: farg1 -type(SwigClassWrapper) :: farg2 -integer(C_INT) :: farg3 - -call SWIG_string_to_chararray(filename, farg1_chars, farg1) -farg2 = pcomm%swigdata -farg3 = SWIG_logical_to_int(callfillcomplete) -fresult = swigc_TpetraReader_readSparseGraphFile__SWIG_2(farg1, farg2, farg3) -swig_result%swigdata = fresult -end function +class(ParameterList), intent(in) :: constructorparams -function TpetraReader_readSparseGraphFile__SWIG_3(filename, pcomm) & -result(swig_result) -use, intrinsic :: ISO_C_BINDING -type(TpetraCrsGraph) :: swig_result -character(kind=C_CHAR, len=*), target :: filename -character(kind=C_CHAR), dimension(:), allocatable, target :: farg1_chars -class(TeuchosComm), intent(in) :: pcomm +class(ParameterList), intent(in) :: fillcompleteparams type(SwigClassWrapper) :: fresult type(SwigArrayWrapper) :: farg1 type(SwigClassWrapper) :: farg2 +type(SwigClassWrapper) :: farg3 +type(SwigClassWrapper) :: farg4 call SWIG_string_to_chararray(filename, farg1_chars, farg1) farg2 = pcomm%swigdata -fresult = swigc_TpetraReader_readSparseGraphFile__SWIG_3(farg1, farg2) +farg3 = constructorparams%swigdata +farg4 = fillcompleteparams%swigdata +fresult = swigc_TpetraReader_readSparseGraphFile__SWIG_2(farg1, farg2, farg3, farg4) swig_result%swigdata = fresult end function -function TpetraReader_readSparseGraphFile__SWIG_4(filename, pcomm, constructorparams, fillcompleteparams, tolerant, debug) & +function TpetraReader_readSparseGraphFile__SWIG_3(filename, rowmap, colmap, domainmap, rangemap, callfillcomplete) & result(swig_result) use, intrinsic :: ISO_C_BINDING type(TpetraCrsGraph) :: swig_result character(kind=C_CHAR, len=*), target :: filename character(kind=C_CHAR), dimension(:), allocatable, target :: farg1_chars -class(TeuchosComm), intent(in) :: pcomm +class(TpetraMap), intent(in) :: rowmap -class(ParameterList), intent(in) :: constructorparams +class(TpetraMap), intent(inout) :: colmap -class(ParameterList), intent(in) :: fillcompleteparams +class(TpetraMap), intent(in) :: domainmap -logical, intent(in) :: tolerant -logical, intent(in) :: debug +class(TpetraMap), intent(in) :: rangemap + +logical, intent(in) :: callfillcomplete type(SwigClassWrapper) :: fresult type(SwigArrayWrapper) :: farg1 type(SwigClassWrapper) :: farg2 type(SwigClassWrapper) :: farg3 type(SwigClassWrapper) :: farg4 -integer(C_INT) :: farg5 +type(SwigClassWrapper) :: farg5 integer(C_INT) :: farg6 call SWIG_string_to_chararray(filename, farg1_chars, farg1) -farg2 = pcomm%swigdata -farg3 = constructorparams%swigdata -farg4 = fillcompleteparams%swigdata -farg5 = SWIG_logical_to_int(tolerant) -farg6 = SWIG_logical_to_int(debug) -fresult = swigc_TpetraReader_readSparseGraphFile__SWIG_4(farg1, farg2, farg3, farg4, farg5, farg6) +farg2 = rowmap%swigdata +farg3 = colmap%swigdata +farg4 = domainmap%swigdata +farg5 = rangemap%swigdata +farg6 = SWIG_logical_to_int(callfillcomplete) +fresult = swigc_TpetraReader_readSparseGraphFile__SWIG_3(farg1, farg2, farg3, farg4, farg5, farg6) swig_result%swigdata = fresult end function -function TpetraReader_readSparseGraphFile__SWIG_5(filename, pcomm, constructorparams, fillcompleteparams, tolerant) & +function TpetraReader_readSparseGraphFile__SWIG_4(filename, rowmap, colmap, domainmap, rangemap) & result(swig_result) use, intrinsic :: ISO_C_BINDING type(TpetraCrsGraph) :: swig_result character(kind=C_CHAR, len=*), target :: filename character(kind=C_CHAR), dimension(:), allocatable, target :: farg1_chars -class(TeuchosComm), intent(in) :: pcomm +class(TpetraMap), intent(in) :: rowmap -class(ParameterList), intent(in) :: constructorparams +class(TpetraMap), intent(inout) :: colmap -class(ParameterList), intent(in) :: fillcompleteparams +class(TpetraMap), intent(in) :: domainmap -logical, intent(in) :: tolerant +class(TpetraMap), intent(in) :: rangemap type(SwigClassWrapper) :: fresult type(SwigArrayWrapper) :: farg1 type(SwigClassWrapper) :: farg2 type(SwigClassWrapper) :: farg3 type(SwigClassWrapper) :: farg4 -integer(C_INT) :: farg5 +type(SwigClassWrapper) :: farg5 call SWIG_string_to_chararray(filename, farg1_chars, farg1) -farg2 = pcomm%swigdata -farg3 = constructorparams%swigdata -farg4 = fillcompleteparams%swigdata -farg5 = SWIG_logical_to_int(tolerant) -fresult = swigc_TpetraReader_readSparseGraphFile__SWIG_5(farg1, farg2, farg3, farg4, farg5) +farg2 = rowmap%swigdata +farg3 = colmap%swigdata +farg4 = domainmap%swigdata +farg5 = rangemap%swigdata +fresult = swigc_TpetraReader_readSparseGraphFile__SWIG_4(farg1, farg2, farg3, farg4, farg5) swig_result%swigdata = fresult end function -function TpetraReader_readSparseGraphFile__SWIG_6(filename, pcomm, constructorparams, fillcompleteparams) & +function TpetraReader_readSparseFile__SWIG_0(filename, pcomm, callfillcomplete) & result(swig_result) use, intrinsic :: ISO_C_BINDING -type(TpetraCrsGraph) :: swig_result +type(TpetraCrsMatrix) :: swig_result character(kind=C_CHAR, len=*), target :: filename character(kind=C_CHAR), dimension(:), allocatable, target :: farg1_chars class(TeuchosComm), intent(in) :: pcomm -class(ParameterList), intent(in) :: constructorparams - -class(ParameterList), intent(in) :: fillcompleteparams +logical, intent(in) :: callfillcomplete type(SwigClassWrapper) :: fresult type(SwigArrayWrapper) :: farg1 type(SwigClassWrapper) :: farg2 -type(SwigClassWrapper) :: farg3 -type(SwigClassWrapper) :: farg4 +integer(C_INT) :: farg3 call SWIG_string_to_chararray(filename, farg1_chars, farg1) farg2 = pcomm%swigdata -farg3 = constructorparams%swigdata -farg4 = fillcompleteparams%swigdata -fresult = swigc_TpetraReader_readSparseGraphFile__SWIG_6(farg1, farg2, farg3, farg4) +farg3 = SWIG_logical_to_int(callfillcomplete) +fresult = swigc_TpetraReader_readSparseFile__SWIG_0(farg1, farg2, farg3) swig_result%swigdata = fresult end function -function TpetraReader_readSparseGraphFile__SWIG_7(filename, rowmap, colmap, domainmap, rangemap, callfillcomplete, tolerant, & - debug) & +function TpetraReader_readSparseFile__SWIG_1(filename, pcomm) & result(swig_result) use, intrinsic :: ISO_C_BINDING -type(TpetraCrsGraph) :: swig_result +type(TpetraCrsMatrix) :: swig_result character(kind=C_CHAR, len=*), target :: filename character(kind=C_CHAR), dimension(:), allocatable, target :: farg1_chars -class(TpetraMap), intent(in) :: rowmap - -class(TpetraMap), intent(inout) :: colmap - -class(TpetraMap), intent(in) :: domainmap - -class(TpetraMap), intent(in) :: rangemap - -logical, intent(in) :: callfillcomplete -logical, intent(in) :: tolerant -logical, intent(in) :: debug +class(TeuchosComm), intent(in) :: pcomm type(SwigClassWrapper) :: fresult type(SwigArrayWrapper) :: farg1 type(SwigClassWrapper) :: farg2 -type(SwigClassWrapper) :: farg3 -type(SwigClassWrapper) :: farg4 -type(SwigClassWrapper) :: farg5 -integer(C_INT) :: farg6 -integer(C_INT) :: farg7 -integer(C_INT) :: farg8 call SWIG_string_to_chararray(filename, farg1_chars, farg1) -farg2 = rowmap%swigdata -farg3 = colmap%swigdata -farg4 = domainmap%swigdata -farg5 = rangemap%swigdata -farg6 = SWIG_logical_to_int(callfillcomplete) -farg7 = SWIG_logical_to_int(tolerant) -farg8 = SWIG_logical_to_int(debug) -fresult = swigc_TpetraReader_readSparseGraphFile__SWIG_7(farg1, farg2, farg3, farg4, farg5, farg6, farg7, farg8) +farg2 = pcomm%swigdata +fresult = swigc_TpetraReader_readSparseFile__SWIG_1(farg1, farg2) swig_result%swigdata = fresult end function -function TpetraReader_readSparseGraphFile__SWIG_8(filename, rowmap, colmap, domainmap, rangemap, callfillcomplete, tolerant) & +function TpetraReader_readSparseFile__SWIG_2(filename, pcomm, constructorparams, fillcompleteparams) & result(swig_result) use, intrinsic :: ISO_C_BINDING -type(TpetraCrsGraph) :: swig_result +type(TpetraCrsMatrix) :: swig_result character(kind=C_CHAR, len=*), target :: filename character(kind=C_CHAR), dimension(:), allocatable, target :: farg1_chars -class(TpetraMap), intent(in) :: rowmap - -class(TpetraMap), intent(inout) :: colmap - -class(TpetraMap), intent(in) :: domainmap +class(TeuchosComm), intent(in) :: pcomm -class(TpetraMap), intent(in) :: rangemap +class(ParameterList), intent(in) :: constructorparams -logical, intent(in) :: callfillcomplete -logical, intent(in) :: tolerant +class(ParameterList), intent(in) :: fillcompleteparams type(SwigClassWrapper) :: fresult type(SwigArrayWrapper) :: farg1 type(SwigClassWrapper) :: farg2 type(SwigClassWrapper) :: farg3 type(SwigClassWrapper) :: farg4 -type(SwigClassWrapper) :: farg5 -integer(C_INT) :: farg6 -integer(C_INT) :: farg7 call SWIG_string_to_chararray(filename, farg1_chars, farg1) -farg2 = rowmap%swigdata -farg3 = colmap%swigdata -farg4 = domainmap%swigdata -farg5 = rangemap%swigdata -farg6 = SWIG_logical_to_int(callfillcomplete) -farg7 = SWIG_logical_to_int(tolerant) -fresult = swigc_TpetraReader_readSparseGraphFile__SWIG_8(farg1, farg2, farg3, farg4, farg5, farg6, farg7) +farg2 = pcomm%swigdata +farg3 = constructorparams%swigdata +farg4 = fillcompleteparams%swigdata +fresult = swigc_TpetraReader_readSparseFile__SWIG_2(farg1, farg2, farg3, farg4) swig_result%swigdata = fresult end function -function TpetraReader_readSparseGraphFile__SWIG_9(filename, rowmap, colmap, domainmap, rangemap, callfillcomplete) & +function TpetraReader_readSparseFile__SWIG_3(filename, rowmap, colmap, domainmap, rangemap, callfillcomplete) & result(swig_result) use, intrinsic :: ISO_C_BINDING -type(TpetraCrsGraph) :: swig_result +type(TpetraCrsMatrix) :: swig_result character(kind=C_CHAR, len=*), target :: filename character(kind=C_CHAR), dimension(:), allocatable, target :: farg1_chars class(TpetraMap), intent(in) :: rowmap @@ -11347,14 +10951,14 @@ function TpetraReader_readSparseGraphFile__SWIG_9(filename, rowmap, colmap, doma farg4 = domainmap%swigdata farg5 = rangemap%swigdata farg6 = SWIG_logical_to_int(callfillcomplete) -fresult = swigc_TpetraReader_readSparseGraphFile__SWIG_9(farg1, farg2, farg3, farg4, farg5, farg6) +fresult = swigc_TpetraReader_readSparseFile__SWIG_3(farg1, farg2, farg3, farg4, farg5, farg6) swig_result%swigdata = fresult end function -function TpetraReader_readSparseGraphFile__SWIG_10(filename, rowmap, colmap, domainmap, rangemap) & +function TpetraReader_readSparseFile__SWIG_4(filename, rowmap, colmap, domainmap, rangemap) & result(swig_result) use, intrinsic :: ISO_C_BINDING -type(TpetraCrsGraph) :: swig_result +type(TpetraCrsMatrix) :: swig_result character(kind=C_CHAR, len=*), target :: filename character(kind=C_CHAR), dimension(:), allocatable, target :: farg1_chars class(TpetraMap), intent(in) :: rowmap @@ -11377,680 +10981,142 @@ function TpetraReader_readSparseGraphFile__SWIG_10(filename, rowmap, colmap, dom farg3 = colmap%swigdata farg4 = domainmap%swigdata farg5 = rangemap%swigdata -fresult = swigc_TpetraReader_readSparseGraphFile__SWIG_10(farg1, farg2, farg3, farg4, farg5) +fresult = swigc_TpetraReader_readSparseFile__SWIG_4(farg1, farg2, farg3, farg4, farg5) swig_result%swigdata = fresult end function -function TpetraReader_readSparseFile__SWIG_0(filename, pcomm, callfillcomplete, tolerant, debug) & +function TpetraReader_readDenseFile(filename, comm, map) & result(swig_result) use, intrinsic :: ISO_C_BINDING -type(TpetraCrsMatrix) :: swig_result +type(TpetraMultiVector) :: swig_result character(kind=C_CHAR, len=*), target :: filename character(kind=C_CHAR), dimension(:), allocatable, target :: farg1_chars -class(TeuchosComm), intent(in) :: pcomm +class(TeuchosComm), intent(in) :: comm -logical, intent(in) :: callfillcomplete -logical, intent(in) :: tolerant -logical, intent(in) :: debug +class(TpetraMap), intent(inout) :: map type(SwigClassWrapper) :: fresult type(SwigArrayWrapper) :: farg1 type(SwigClassWrapper) :: farg2 -integer(C_INT) :: farg3 -integer(C_INT) :: farg4 -integer(C_INT) :: farg5 +type(SwigClassWrapper) :: farg3 call SWIG_string_to_chararray(filename, farg1_chars, farg1) -farg2 = pcomm%swigdata -farg3 = SWIG_logical_to_int(callfillcomplete) -farg4 = SWIG_logical_to_int(tolerant) -farg5 = SWIG_logical_to_int(debug) -fresult = swigc_TpetraReader_readSparseFile__SWIG_0(farg1, farg2, farg3, farg4, farg5) +farg2 = comm%swigdata +farg3 = map%swigdata +fresult = swigc_TpetraReader_readDenseFile(farg1, farg2, farg3) swig_result%swigdata = fresult end function -function TpetraReader_readSparseFile__SWIG_1(filename, pcomm, callfillcomplete, tolerant) & +function TpetraReader_readMapFile(filename, comm) & result(swig_result) use, intrinsic :: ISO_C_BINDING -type(TpetraCrsMatrix) :: swig_result +type(TpetraMap) :: swig_result character(kind=C_CHAR, len=*), target :: filename character(kind=C_CHAR), dimension(:), allocatable, target :: farg1_chars -class(TeuchosComm), intent(in) :: pcomm - -logical, intent(in) :: callfillcomplete -logical, intent(in) :: tolerant +class(TeuchosComm), intent(in) :: comm type(SwigClassWrapper) :: fresult type(SwigArrayWrapper) :: farg1 type(SwigClassWrapper) :: farg2 -integer(C_INT) :: farg3 -integer(C_INT) :: farg4 call SWIG_string_to_chararray(filename, farg1_chars, farg1) -farg2 = pcomm%swigdata -farg3 = SWIG_logical_to_int(callfillcomplete) -farg4 = SWIG_logical_to_int(tolerant) -fresult = swigc_TpetraReader_readSparseFile__SWIG_1(farg1, farg2, farg3, farg4) +farg2 = comm%swigdata +fresult = swigc_TpetraReader_readMapFile(farg1, farg2) swig_result%swigdata = fresult end function -function TpetraReader_readSparseFile__SWIG_2(filename, pcomm, callfillcomplete) & -result(swig_result) +subroutine delete_TpetraReader(self) +use, intrinsic :: ISO_C_BINDING +class(TpetraReader), intent(inout) :: self + +type(SwigClassWrapper) :: farg1 + +farg1 = self%swigdata +if (self%swigdata%mem == SWIG_OWN) then +call swigc_delete_TpetraReader(farg1) +end if +self%swigdata%cptr = C_NULL_PTR +self%swigdata%mem = SWIG_NULL +end subroutine + + subroutine swigf_assignment_TpetraReader(self, other) + use, intrinsic :: ISO_C_BINDING + class(TpetraReader), intent(inout) :: self + type(TpetraReader), intent(in) :: other + call swigc_assignment_TpetraReader(self%swigdata, other%swigdata) + end subroutine +subroutine TpetraWriter_writeSparseFile__SWIG_0(filename, pmatrix, matrixname, matrixdescription) use, intrinsic :: ISO_C_BINDING -type(TpetraCrsMatrix) :: swig_result character(kind=C_CHAR, len=*), target :: filename character(kind=C_CHAR), dimension(:), allocatable, target :: farg1_chars -class(TeuchosComm), intent(in) :: pcomm +class(TpetraCrsMatrix), intent(in) :: pmatrix -logical, intent(in) :: callfillcomplete +character(kind=C_CHAR, len=*), target :: matrixname +character(kind=C_CHAR), dimension(:), allocatable, target :: farg3_chars +character(kind=C_CHAR, len=*), target :: matrixdescription +character(kind=C_CHAR), dimension(:), allocatable, target :: farg4_chars -type(SwigClassWrapper) :: fresult type(SwigArrayWrapper) :: farg1 type(SwigClassWrapper) :: farg2 -integer(C_INT) :: farg3 +type(SwigArrayWrapper) :: farg3 +type(SwigArrayWrapper) :: farg4 call SWIG_string_to_chararray(filename, farg1_chars, farg1) -farg2 = pcomm%swigdata -farg3 = SWIG_logical_to_int(callfillcomplete) -fresult = swigc_TpetraReader_readSparseFile__SWIG_2(farg1, farg2, farg3) -swig_result%swigdata = fresult -end function +farg2 = pmatrix%swigdata +call SWIG_string_to_chararray(matrixname, farg3_chars, farg3) +call SWIG_string_to_chararray(matrixdescription, farg4_chars, farg4) +call swigc_TpetraWriter_writeSparseFile__SWIG_0(farg1, farg2, farg3, farg4) +end subroutine -function TpetraReader_readSparseFile__SWIG_3(filename, pcomm) & -result(swig_result) +subroutine TpetraWriter_writeSparseFile__SWIG_1(filename, pmatrix) use, intrinsic :: ISO_C_BINDING -type(TpetraCrsMatrix) :: swig_result character(kind=C_CHAR, len=*), target :: filename character(kind=C_CHAR), dimension(:), allocatable, target :: farg1_chars -class(TeuchosComm), intent(in) :: pcomm +class(TpetraCrsMatrix), intent(in) :: pmatrix -type(SwigClassWrapper) :: fresult type(SwigArrayWrapper) :: farg1 type(SwigClassWrapper) :: farg2 call SWIG_string_to_chararray(filename, farg1_chars, farg1) -farg2 = pcomm%swigdata -fresult = swigc_TpetraReader_readSparseFile__SWIG_3(farg1, farg2) -swig_result%swigdata = fresult -end function +farg2 = pmatrix%swigdata +call swigc_TpetraWriter_writeSparseFile__SWIG_1(farg1, farg2) +end subroutine -function TpetraReader_readSparseFile__SWIG_4(filename, pcomm, constructorparams, fillcompleteparams, tolerant, debug) & -result(swig_result) +subroutine TpetraWriter_writeSparseGraphFile__SWIG_0(filename, pgraph, graphname, graphdescription) use, intrinsic :: ISO_C_BINDING -type(TpetraCrsMatrix) :: swig_result character(kind=C_CHAR, len=*), target :: filename character(kind=C_CHAR), dimension(:), allocatable, target :: farg1_chars -class(TeuchosComm), intent(in) :: pcomm - -class(ParameterList), intent(in) :: constructorparams - -class(ParameterList), intent(in) :: fillcompleteparams - -logical, intent(in) :: tolerant -logical, intent(in) :: debug - -type(SwigClassWrapper) :: fresult -type(SwigArrayWrapper) :: farg1 -type(SwigClassWrapper) :: farg2 -type(SwigClassWrapper) :: farg3 -type(SwigClassWrapper) :: farg4 -integer(C_INT) :: farg5 -integer(C_INT) :: farg6 - -call SWIG_string_to_chararray(filename, farg1_chars, farg1) -farg2 = pcomm%swigdata -farg3 = constructorparams%swigdata -farg4 = fillcompleteparams%swigdata -farg5 = SWIG_logical_to_int(tolerant) -farg6 = SWIG_logical_to_int(debug) -fresult = swigc_TpetraReader_readSparseFile__SWIG_4(farg1, farg2, farg3, farg4, farg5, farg6) -swig_result%swigdata = fresult -end function - -function TpetraReader_readSparseFile__SWIG_5(filename, pcomm, constructorparams, fillcompleteparams, tolerant) & -result(swig_result) -use, intrinsic :: ISO_C_BINDING -type(TpetraCrsMatrix) :: swig_result -character(kind=C_CHAR, len=*), target :: filename -character(kind=C_CHAR), dimension(:), allocatable, target :: farg1_chars -class(TeuchosComm), intent(in) :: pcomm - -class(ParameterList), intent(in) :: constructorparams - -class(ParameterList), intent(in) :: fillcompleteparams - -logical, intent(in) :: tolerant - -type(SwigClassWrapper) :: fresult -type(SwigArrayWrapper) :: farg1 -type(SwigClassWrapper) :: farg2 -type(SwigClassWrapper) :: farg3 -type(SwigClassWrapper) :: farg4 -integer(C_INT) :: farg5 - -call SWIG_string_to_chararray(filename, farg1_chars, farg1) -farg2 = pcomm%swigdata -farg3 = constructorparams%swigdata -farg4 = fillcompleteparams%swigdata -farg5 = SWIG_logical_to_int(tolerant) -fresult = swigc_TpetraReader_readSparseFile__SWIG_5(farg1, farg2, farg3, farg4, farg5) -swig_result%swigdata = fresult -end function - -function TpetraReader_readSparseFile__SWIG_6(filename, pcomm, constructorparams, fillcompleteparams) & -result(swig_result) -use, intrinsic :: ISO_C_BINDING -type(TpetraCrsMatrix) :: swig_result -character(kind=C_CHAR, len=*), target :: filename -character(kind=C_CHAR), dimension(:), allocatable, target :: farg1_chars -class(TeuchosComm), intent(in) :: pcomm - -class(ParameterList), intent(in) :: constructorparams - -class(ParameterList), intent(in) :: fillcompleteparams - -type(SwigClassWrapper) :: fresult -type(SwigArrayWrapper) :: farg1 -type(SwigClassWrapper) :: farg2 -type(SwigClassWrapper) :: farg3 -type(SwigClassWrapper) :: farg4 - -call SWIG_string_to_chararray(filename, farg1_chars, farg1) -farg2 = pcomm%swigdata -farg3 = constructorparams%swigdata -farg4 = fillcompleteparams%swigdata -fresult = swigc_TpetraReader_readSparseFile__SWIG_6(farg1, farg2, farg3, farg4) -swig_result%swigdata = fresult -end function - -function TpetraReader_readSparseFile__SWIG_7(filename, rowmap, colmap, domainmap, rangemap, callfillcomplete, tolerant, debug) & -result(swig_result) -use, intrinsic :: ISO_C_BINDING -type(TpetraCrsMatrix) :: swig_result -character(kind=C_CHAR, len=*), target :: filename -character(kind=C_CHAR), dimension(:), allocatable, target :: farg1_chars -class(TpetraMap), intent(in) :: rowmap - -class(TpetraMap), intent(inout) :: colmap - -class(TpetraMap), intent(in) :: domainmap - -class(TpetraMap), intent(in) :: rangemap - -logical, intent(in) :: callfillcomplete -logical, intent(in) :: tolerant -logical, intent(in) :: debug - -type(SwigClassWrapper) :: fresult -type(SwigArrayWrapper) :: farg1 -type(SwigClassWrapper) :: farg2 -type(SwigClassWrapper) :: farg3 -type(SwigClassWrapper) :: farg4 -type(SwigClassWrapper) :: farg5 -integer(C_INT) :: farg6 -integer(C_INT) :: farg7 -integer(C_INT) :: farg8 - -call SWIG_string_to_chararray(filename, farg1_chars, farg1) -farg2 = rowmap%swigdata -farg3 = colmap%swigdata -farg4 = domainmap%swigdata -farg5 = rangemap%swigdata -farg6 = SWIG_logical_to_int(callfillcomplete) -farg7 = SWIG_logical_to_int(tolerant) -farg8 = SWIG_logical_to_int(debug) -fresult = swigc_TpetraReader_readSparseFile__SWIG_7(farg1, farg2, farg3, farg4, farg5, farg6, farg7, farg8) -swig_result%swigdata = fresult -end function - -function TpetraReader_readSparseFile__SWIG_8(filename, rowmap, colmap, domainmap, rangemap, callfillcomplete, tolerant) & -result(swig_result) -use, intrinsic :: ISO_C_BINDING -type(TpetraCrsMatrix) :: swig_result -character(kind=C_CHAR, len=*), target :: filename -character(kind=C_CHAR), dimension(:), allocatable, target :: farg1_chars -class(TpetraMap), intent(in) :: rowmap - -class(TpetraMap), intent(inout) :: colmap - -class(TpetraMap), intent(in) :: domainmap - -class(TpetraMap), intent(in) :: rangemap - -logical, intent(in) :: callfillcomplete -logical, intent(in) :: tolerant - -type(SwigClassWrapper) :: fresult -type(SwigArrayWrapper) :: farg1 -type(SwigClassWrapper) :: farg2 -type(SwigClassWrapper) :: farg3 -type(SwigClassWrapper) :: farg4 -type(SwigClassWrapper) :: farg5 -integer(C_INT) :: farg6 -integer(C_INT) :: farg7 - -call SWIG_string_to_chararray(filename, farg1_chars, farg1) -farg2 = rowmap%swigdata -farg3 = colmap%swigdata -farg4 = domainmap%swigdata -farg5 = rangemap%swigdata -farg6 = SWIG_logical_to_int(callfillcomplete) -farg7 = SWIG_logical_to_int(tolerant) -fresult = swigc_TpetraReader_readSparseFile__SWIG_8(farg1, farg2, farg3, farg4, farg5, farg6, farg7) -swig_result%swigdata = fresult -end function - -function TpetraReader_readSparseFile__SWIG_9(filename, rowmap, colmap, domainmap, rangemap, callfillcomplete) & -result(swig_result) -use, intrinsic :: ISO_C_BINDING -type(TpetraCrsMatrix) :: swig_result -character(kind=C_CHAR, len=*), target :: filename -character(kind=C_CHAR), dimension(:), allocatable, target :: farg1_chars -class(TpetraMap), intent(in) :: rowmap - -class(TpetraMap), intent(inout) :: colmap - -class(TpetraMap), intent(in) :: domainmap - -class(TpetraMap), intent(in) :: rangemap - -logical, intent(in) :: callfillcomplete - -type(SwigClassWrapper) :: fresult -type(SwigArrayWrapper) :: farg1 -type(SwigClassWrapper) :: farg2 -type(SwigClassWrapper) :: farg3 -type(SwigClassWrapper) :: farg4 -type(SwigClassWrapper) :: farg5 -integer(C_INT) :: farg6 - -call SWIG_string_to_chararray(filename, farg1_chars, farg1) -farg2 = rowmap%swigdata -farg3 = colmap%swigdata -farg4 = domainmap%swigdata -farg5 = rangemap%swigdata -farg6 = SWIG_logical_to_int(callfillcomplete) -fresult = swigc_TpetraReader_readSparseFile__SWIG_9(farg1, farg2, farg3, farg4, farg5, farg6) -swig_result%swigdata = fresult -end function - -function TpetraReader_readSparseFile__SWIG_10(filename, rowmap, colmap, domainmap, rangemap) & -result(swig_result) -use, intrinsic :: ISO_C_BINDING -type(TpetraCrsMatrix) :: swig_result -character(kind=C_CHAR, len=*), target :: filename -character(kind=C_CHAR), dimension(:), allocatable, target :: farg1_chars -class(TpetraMap), intent(in) :: rowmap - -class(TpetraMap), intent(inout) :: colmap - -class(TpetraMap), intent(in) :: domainmap - -class(TpetraMap), intent(in) :: rangemap - -type(SwigClassWrapper) :: fresult -type(SwigArrayWrapper) :: farg1 -type(SwigClassWrapper) :: farg2 -type(SwigClassWrapper) :: farg3 -type(SwigClassWrapper) :: farg4 -type(SwigClassWrapper) :: farg5 - -call SWIG_string_to_chararray(filename, farg1_chars, farg1) -farg2 = rowmap%swigdata -farg3 = colmap%swigdata -farg4 = domainmap%swigdata -farg5 = rangemap%swigdata -fresult = swigc_TpetraReader_readSparseFile__SWIG_10(farg1, farg2, farg3, farg4, farg5) -swig_result%swigdata = fresult -end function - -function TpetraReader_readDenseFile__SWIG_0(filename, comm, map, tolerant, debug) & -result(swig_result) -use, intrinsic :: ISO_C_BINDING -type(TpetraMultiVector) :: swig_result -character(kind=C_CHAR, len=*), target :: filename -character(kind=C_CHAR), dimension(:), allocatable, target :: farg1_chars -class(TeuchosComm), intent(in) :: comm - -class(TpetraMap), intent(inout) :: map - -logical, intent(in) :: tolerant -logical, intent(in) :: debug - -type(SwigClassWrapper) :: fresult -type(SwigArrayWrapper) :: farg1 -type(SwigClassWrapper) :: farg2 -type(SwigClassWrapper) :: farg3 -integer(C_INT) :: farg4 -integer(C_INT) :: farg5 - -call SWIG_string_to_chararray(filename, farg1_chars, farg1) -farg2 = comm%swigdata -farg3 = map%swigdata -farg4 = SWIG_logical_to_int(tolerant) -farg5 = SWIG_logical_to_int(debug) -fresult = swigc_TpetraReader_readDenseFile__SWIG_0(farg1, farg2, farg3, farg4, farg5) -swig_result%swigdata = fresult -end function - -function TpetraReader_readDenseFile__SWIG_1(filename, comm, map, tolerant) & -result(swig_result) -use, intrinsic :: ISO_C_BINDING -type(TpetraMultiVector) :: swig_result -character(kind=C_CHAR, len=*), target :: filename -character(kind=C_CHAR), dimension(:), allocatable, target :: farg1_chars -class(TeuchosComm), intent(in) :: comm - -class(TpetraMap), intent(inout) :: map - -logical, intent(in) :: tolerant - -type(SwigClassWrapper) :: fresult -type(SwigArrayWrapper) :: farg1 -type(SwigClassWrapper) :: farg2 -type(SwigClassWrapper) :: farg3 -integer(C_INT) :: farg4 - -call SWIG_string_to_chararray(filename, farg1_chars, farg1) -farg2 = comm%swigdata -farg3 = map%swigdata -farg4 = SWIG_logical_to_int(tolerant) -fresult = swigc_TpetraReader_readDenseFile__SWIG_1(farg1, farg2, farg3, farg4) -swig_result%swigdata = fresult -end function - -function TpetraReader_readDenseFile__SWIG_2(filename, comm, map) & -result(swig_result) -use, intrinsic :: ISO_C_BINDING -type(TpetraMultiVector) :: swig_result -character(kind=C_CHAR, len=*), target :: filename -character(kind=C_CHAR), dimension(:), allocatable, target :: farg1_chars -class(TeuchosComm), intent(in) :: comm - -class(TpetraMap), intent(inout) :: map - -type(SwigClassWrapper) :: fresult -type(SwigArrayWrapper) :: farg1 -type(SwigClassWrapper) :: farg2 -type(SwigClassWrapper) :: farg3 - -call SWIG_string_to_chararray(filename, farg1_chars, farg1) -farg2 = comm%swigdata -farg3 = map%swigdata -fresult = swigc_TpetraReader_readDenseFile__SWIG_2(farg1, farg2, farg3) -swig_result%swigdata = fresult -end function - -function TpetraReader_readMapFile__SWIG_0(filename, comm, tolerant, debug) & -result(swig_result) -use, intrinsic :: ISO_C_BINDING -type(TpetraMap) :: swig_result -character(kind=C_CHAR, len=*), target :: filename -character(kind=C_CHAR), dimension(:), allocatable, target :: farg1_chars -class(TeuchosComm), intent(in) :: comm - -logical, intent(in) :: tolerant -logical, intent(in) :: debug - -type(SwigClassWrapper) :: fresult -type(SwigArrayWrapper) :: farg1 -type(SwigClassWrapper) :: farg2 -integer(C_INT) :: farg3 -integer(C_INT) :: farg4 - -call SWIG_string_to_chararray(filename, farg1_chars, farg1) -farg2 = comm%swigdata -farg3 = SWIG_logical_to_int(tolerant) -farg4 = SWIG_logical_to_int(debug) -fresult = swigc_TpetraReader_readMapFile__SWIG_0(farg1, farg2, farg3, farg4) -swig_result%swigdata = fresult -end function - -function TpetraReader_readMapFile__SWIG_1(filename, comm, tolerant) & -result(swig_result) -use, intrinsic :: ISO_C_BINDING -type(TpetraMap) :: swig_result -character(kind=C_CHAR, len=*), target :: filename -character(kind=C_CHAR), dimension(:), allocatable, target :: farg1_chars -class(TeuchosComm), intent(in) :: comm - -logical, intent(in) :: tolerant - -type(SwigClassWrapper) :: fresult -type(SwigArrayWrapper) :: farg1 -type(SwigClassWrapper) :: farg2 -integer(C_INT) :: farg3 - -call SWIG_string_to_chararray(filename, farg1_chars, farg1) -farg2 = comm%swigdata -farg3 = SWIG_logical_to_int(tolerant) -fresult = swigc_TpetraReader_readMapFile__SWIG_1(farg1, farg2, farg3) -swig_result%swigdata = fresult -end function - -function TpetraReader_readMapFile__SWIG_2(filename, comm) & -result(swig_result) -use, intrinsic :: ISO_C_BINDING -type(TpetraMap) :: swig_result -character(kind=C_CHAR, len=*), target :: filename -character(kind=C_CHAR), dimension(:), allocatable, target :: farg1_chars -class(TeuchosComm), intent(in) :: comm - -type(SwigClassWrapper) :: fresult -type(SwigArrayWrapper) :: farg1 -type(SwigClassWrapper) :: farg2 - -call SWIG_string_to_chararray(filename, farg1_chars, farg1) -farg2 = comm%swigdata -fresult = swigc_TpetraReader_readMapFile__SWIG_2(farg1, farg2) -swig_result%swigdata = fresult -end function - -function new_TpetraReader() & -result(self) -use, intrinsic :: ISO_C_BINDING -type(TpetraReader) :: self - -type(SwigClassWrapper) :: fresult - -fresult = swigc_new_TpetraReader() -self%swigdata = fresult -end function - -subroutine delete_TpetraReader(self) -use, intrinsic :: ISO_C_BINDING -class(TpetraReader), intent(inout) :: self - -type(SwigClassWrapper) :: farg1 - -farg1 = self%swigdata -if (self%swigdata%mem == SWIG_OWN) then -call swigc_delete_TpetraReader(farg1) -end if -self%swigdata%cptr = C_NULL_PTR -self%swigdata%mem = SWIG_NULL -end subroutine - - subroutine swigf_assignment_TpetraReader(self, other) - use, intrinsic :: ISO_C_BINDING - class(TpetraReader), intent(inout) :: self - type(TpetraReader), intent(in) :: other - call swigc_assignment_TpetraReader(self%swigdata, other%swigdata) - end subroutine -subroutine TpetraWriter_writeMapFile(filename, map) -use, intrinsic :: ISO_C_BINDING -character(kind=C_CHAR, len=*), target :: filename -character(kind=C_CHAR), dimension(:), allocatable, target :: farg1_chars -class(TpetraMap), intent(in) :: map - -type(SwigArrayWrapper) :: farg1 -type(SwigClassWrapper) :: farg2 - -call SWIG_string_to_chararray(filename, farg1_chars, farg1) -farg2 = map%swigdata -call swigc_TpetraWriter_writeMapFile(farg1, farg2) -end subroutine - -subroutine TpetraWriter_writeSparseFile__SWIG_0(filename, pmatrix, matrixname, matrixdescription, debug) -use, intrinsic :: ISO_C_BINDING -character(kind=C_CHAR, len=*), target :: filename -character(kind=C_CHAR), dimension(:), allocatable, target :: farg1_chars -class(TpetraCrsMatrix), intent(in) :: pmatrix - -character(kind=C_CHAR, len=*), target :: matrixname -character(kind=C_CHAR), dimension(:), allocatable, target :: farg3_chars -character(kind=C_CHAR, len=*), target :: matrixdescription -character(kind=C_CHAR), dimension(:), allocatable, target :: farg4_chars -logical, intent(in) :: debug - -type(SwigArrayWrapper) :: farg1 -type(SwigClassWrapper) :: farg2 -type(SwigArrayWrapper) :: farg3 -type(SwigArrayWrapper) :: farg4 -integer(C_INT) :: farg5 - -call SWIG_string_to_chararray(filename, farg1_chars, farg1) -farg2 = pmatrix%swigdata -call SWIG_string_to_chararray(matrixname, farg3_chars, farg3) -call SWIG_string_to_chararray(matrixdescription, farg4_chars, farg4) -farg5 = SWIG_logical_to_int(debug) -call swigc_TpetraWriter_writeSparseFile__SWIG_0(farg1, farg2, farg3, farg4, farg5) -end subroutine - -subroutine TpetraWriter_writeSparseFile__SWIG_1(filename, pmatrix, matrixname, matrixdescription) -use, intrinsic :: ISO_C_BINDING -character(kind=C_CHAR, len=*), target :: filename -character(kind=C_CHAR), dimension(:), allocatable, target :: farg1_chars -class(TpetraCrsMatrix), intent(in) :: pmatrix - -character(kind=C_CHAR, len=*), target :: matrixname -character(kind=C_CHAR), dimension(:), allocatable, target :: farg3_chars -character(kind=C_CHAR, len=*), target :: matrixdescription -character(kind=C_CHAR), dimension(:), allocatable, target :: farg4_chars - -type(SwigArrayWrapper) :: farg1 -type(SwigClassWrapper) :: farg2 -type(SwigArrayWrapper) :: farg3 -type(SwigArrayWrapper) :: farg4 - -call SWIG_string_to_chararray(filename, farg1_chars, farg1) -farg2 = pmatrix%swigdata -call SWIG_string_to_chararray(matrixname, farg3_chars, farg3) -call SWIG_string_to_chararray(matrixdescription, farg4_chars, farg4) -call swigc_TpetraWriter_writeSparseFile__SWIG_1(farg1, farg2, farg3, farg4) -end subroutine - -subroutine TpetraWriter_writeSparseFile__SWIG_2(filename, pmatrix, debug) -use, intrinsic :: ISO_C_BINDING -character(kind=C_CHAR, len=*), target :: filename -character(kind=C_CHAR), dimension(:), allocatable, target :: farg1_chars -class(TpetraCrsMatrix), intent(in) :: pmatrix - -logical, intent(in) :: debug - -type(SwigArrayWrapper) :: farg1 -type(SwigClassWrapper) :: farg2 -integer(C_INT) :: farg3 - -call SWIG_string_to_chararray(filename, farg1_chars, farg1) -farg2 = pmatrix%swigdata -farg3 = SWIG_logical_to_int(debug) -call swigc_TpetraWriter_writeSparseFile__SWIG_2(farg1, farg2, farg3) -end subroutine - -subroutine TpetraWriter_writeSparseFile__SWIG_3(filename, pmatrix) -use, intrinsic :: ISO_C_BINDING -character(kind=C_CHAR, len=*), target :: filename -character(kind=C_CHAR), dimension(:), allocatable, target :: farg1_chars -class(TpetraCrsMatrix), intent(in) :: pmatrix - -type(SwigArrayWrapper) :: farg1 -type(SwigClassWrapper) :: farg2 - -call SWIG_string_to_chararray(filename, farg1_chars, farg1) -farg2 = pmatrix%swigdata -call swigc_TpetraWriter_writeSparseFile__SWIG_3(farg1, farg2) -end subroutine - -subroutine TpetraWriter_writeSparseGraphFile__SWIG_0(filename, pgraph, graphname, graphdescription, debug) -use, intrinsic :: ISO_C_BINDING -character(kind=C_CHAR, len=*), target :: filename -character(kind=C_CHAR), dimension(:), allocatable, target :: farg1_chars -class(TpetraCrsGraph), intent(in) :: pgraph +class(TpetraCrsGraph), intent(in) :: pgraph character(kind=C_CHAR, len=*), target :: graphname character(kind=C_CHAR), dimension(:), allocatable, target :: farg3_chars character(kind=C_CHAR, len=*), target :: graphdescription character(kind=C_CHAR), dimension(:), allocatable, target :: farg4_chars -logical, intent(in) :: debug type(SwigArrayWrapper) :: farg1 type(SwigClassWrapper) :: farg2 type(SwigArrayWrapper) :: farg3 type(SwigArrayWrapper) :: farg4 -integer(C_INT) :: farg5 call SWIG_string_to_chararray(filename, farg1_chars, farg1) farg2 = pgraph%swigdata call SWIG_string_to_chararray(graphname, farg3_chars, farg3) call SWIG_string_to_chararray(graphdescription, farg4_chars, farg4) -farg5 = SWIG_logical_to_int(debug) -call swigc_TpetraWriter_writeSparseGraphFile__SWIG_0(farg1, farg2, farg3, farg4, farg5) +call swigc_TpetraWriter_writeSparseGraphFile__SWIG_0(farg1, farg2, farg3, farg4) end subroutine -subroutine TpetraWriter_writeSparseGraphFile__SWIG_1(filename, pgraph, graphname, graphdescription) +subroutine TpetraWriter_writeSparseGraphFile__SWIG_1(filename, pgraph) use, intrinsic :: ISO_C_BINDING character(kind=C_CHAR, len=*), target :: filename character(kind=C_CHAR), dimension(:), allocatable, target :: farg1_chars class(TpetraCrsGraph), intent(in) :: pgraph -character(kind=C_CHAR, len=*), target :: graphname -character(kind=C_CHAR), dimension(:), allocatable, target :: farg3_chars -character(kind=C_CHAR, len=*), target :: graphdescription -character(kind=C_CHAR), dimension(:), allocatable, target :: farg4_chars - type(SwigArrayWrapper) :: farg1 type(SwigClassWrapper) :: farg2 -type(SwigArrayWrapper) :: farg3 -type(SwigArrayWrapper) :: farg4 call SWIG_string_to_chararray(filename, farg1_chars, farg1) farg2 = pgraph%swigdata -call SWIG_string_to_chararray(graphname, farg3_chars, farg3) -call SWIG_string_to_chararray(graphdescription, farg4_chars, farg4) -call swigc_TpetraWriter_writeSparseGraphFile__SWIG_1(farg1, farg2, farg3, farg4) -end subroutine - -subroutine TpetraWriter_writeSparseGraphFile__SWIG_2(filename, pgraph, debug) -use, intrinsic :: ISO_C_BINDING -character(kind=C_CHAR, len=*), target :: filename -character(kind=C_CHAR), dimension(:), allocatable, target :: farg1_chars -class(TpetraCrsGraph), intent(in) :: pgraph - -logical, intent(in) :: debug - -type(SwigArrayWrapper) :: farg1 -type(SwigClassWrapper) :: farg2 -integer(C_INT) :: farg3 - -call SWIG_string_to_chararray(filename, farg1_chars, farg1) -farg2 = pgraph%swigdata -farg3 = SWIG_logical_to_int(debug) -call swigc_TpetraWriter_writeSparseGraphFile__SWIG_2(farg1, farg2, farg3) -end subroutine - -subroutine TpetraWriter_writeSparseGraphFile__SWIG_3(filename, pgraph) -use, intrinsic :: ISO_C_BINDING -character(kind=C_CHAR, len=*), target :: filename -character(kind=C_CHAR), dimension(:), allocatable, target :: farg1_chars -class(TpetraCrsGraph), intent(in) :: pgraph - -type(SwigArrayWrapper) :: farg1 -type(SwigClassWrapper) :: farg2 - -call SWIG_string_to_chararray(filename, farg1_chars, farg1) -farg2 = pgraph%swigdata -call swigc_TpetraWriter_writeSparseGraphFile__SWIG_3(farg1, farg2) +call swigc_TpetraWriter_writeSparseGraphFile__SWIG_1(farg1, farg2) end subroutine subroutine TpetraWriter_writeDenseFile__SWIG_0(filename, x, matrixname, matrixdescription) @@ -12090,17 +11156,6 @@ subroutine TpetraWriter_writeDenseFile__SWIG_1(filename, x) call swigc_TpetraWriter_writeDenseFile__SWIG_1(farg1, farg2) end subroutine -function new_TpetraWriter() & -result(self) -use, intrinsic :: ISO_C_BINDING -type(TpetraWriter) :: self - -type(SwigClassWrapper) :: fresult - -fresult = swigc_new_TpetraWriter() -self%swigdata = fresult -end function - subroutine delete_TpetraWriter(self) use, intrinsic :: ISO_C_BINDING class(TpetraWriter), intent(inout) :: self diff --git a/src/tpetra/src/swig/fortpetraFORTRAN_wrap.cxx b/src/tpetra/src/swig/fortpetraFORTRAN_wrap.cxx index 0cdc7308..5af86baa 100644 --- a/src/tpetra/src/swig/fortpetraFORTRAN_wrap.cxx +++ b/src/tpetra/src/swig/fortpetraFORTRAN_wrap.cxx @@ -813,55 +813,9 @@ namespace ForTrilinos { } -#include "Teuchos_RCP.hpp" #include "MatrixMarket_Tpetra.hpp" - typedef Tpetra::CrsMatrix CMT; - -SWIGINTERN Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::sparse_graph_type > Tpetra_MatrixMarket_Reader_Sl_CMT_Sg__readSparseGraphFile__SWIG_0(std::string const &filename,Teuchos::RCP< Teuchos::Comm< int > const > const &pComm,bool const callFillComplete=true,bool const tolerant=false,bool const debug=false){ - return Tpetra::MatrixMarket::Reader::readSparseGraphFile(filename, pComm, callFillComplete, tolerant, debug); - } -SWIGINTERN Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::sparse_graph_type > Tpetra_MatrixMarket_Reader_Sl_CMT_Sg__readSparseGraphFile__SWIG_4(std::string const &filename,Teuchos::RCP< Teuchos::Comm< int > const > const &pComm,Teuchos::RCP< Teuchos::ParameterList > const &constructorParams,Teuchos::RCP< Teuchos::ParameterList > const &fillCompleteParams,bool const tolerant=false,bool const debug=false){ - return Tpetra::MatrixMarket::Reader::readSparseGraphFile(filename, pComm, constructorParams, fillCompleteParams, tolerant, debug); - } -SWIGINTERN Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::sparse_graph_type > Tpetra_MatrixMarket_Reader_Sl_CMT_Sg__readSparseGraphFile__SWIG_7(std::string const &filename,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > const &rowMap,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > &colMap,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > const &domainMap,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > const &rangeMap,bool const callFillComplete=true,bool const tolerant=false,bool const debug=false){ - return Tpetra::MatrixMarket::Reader::readSparseGraphFile(filename, rowMap, colMap, domainMap, rangeMap, callFillComplete, tolerant, debug); - } -SWIGINTERN Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::sparse_matrix_type > Tpetra_MatrixMarket_Reader_Sl_CMT_Sg__readSparseFile__SWIG_0(std::string const &filename,Teuchos::RCP< Teuchos::Comm< int > const > const &pComm,bool const callFillComplete=true,bool const tolerant=false,bool const debug=false){ - return Tpetra::MatrixMarket::Reader::readSparseFile(filename, pComm, callFillComplete, tolerant, debug); - } -SWIGINTERN Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::sparse_matrix_type > Tpetra_MatrixMarket_Reader_Sl_CMT_Sg__readSparseFile__SWIG_4(std::string const &filename,Teuchos::RCP< Teuchos::Comm< int > const > const &pComm,Teuchos::RCP< Teuchos::ParameterList > const &constructorParams,Teuchos::RCP< Teuchos::ParameterList > const &fillCompleteParams,bool const tolerant=false,bool const debug=false){ - return Tpetra::MatrixMarket::Reader::readSparseFile(filename, pComm, constructorParams, fillCompleteParams, tolerant, debug); - } -SWIGINTERN Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::sparse_matrix_type > Tpetra_MatrixMarket_Reader_Sl_CMT_Sg__readSparseFile__SWIG_7(std::string const &filename,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > const &rowMap,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > &colMap,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > const &domainMap,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > const &rangeMap,bool const callFillComplete=true,bool const tolerant=false,bool const debug=false){ - return Tpetra::MatrixMarket::Reader::readSparseFile(filename, rowMap, colMap, domainMap, rangeMap, callFillComplete, tolerant, debug); - } -SWIGINTERN Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::multivector_type > Tpetra_MatrixMarket_Reader_Sl_CMT_Sg__readDenseFile__SWIG_0(std::string const &filename,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::comm_type const > const &comm,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > &map,bool const tolerant=false,bool const debug=false){ - return Tpetra::MatrixMarket::Reader::readDenseFile(filename, comm, map, tolerant, debug); - } -SWIGINTERN Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > Tpetra_MatrixMarket_Reader_Sl_CMT_Sg__readMapFile__SWIG_0(std::string const &filename,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::comm_type const > const &comm,bool const tolerant=false,bool const debug=false){ - return Tpetra::MatrixMarket::Reader::readMapFile(filename, comm, tolerant, debug); - } -SWIGINTERN void Tpetra_MatrixMarket_Writer_Sl_CMT_Sg__writeSparseFile__SWIG_0(std::string const &filename,Teuchos::RCP< Tpetra::MatrixMarket::Writer< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > >::sparse_matrix_type const > const &pMatrix,std::string const &matrixName,std::string const &matrixDescription,bool const debug=false){ - Tpetra::MatrixMarket::Writer::writeSparseFile(filename, pMatrix, matrixName, matrixDescription, debug); - } -SWIGINTERN void Tpetra_MatrixMarket_Writer_Sl_CMT_Sg__writeSparseFile__SWIG_2(std::string const &filename,Teuchos::RCP< Tpetra::MatrixMarket::Writer< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > >::sparse_matrix_type const > const &pMatrix,bool const debug=false){ - Tpetra::MatrixMarket::Writer::writeSparseFile(filename, pMatrix, debug); - } -SWIGINTERN void Tpetra_MatrixMarket_Writer_Sl_CMT_Sg__writeSparseGraphFile__SWIG_0(std::string const &filename,Teuchos::RCP< Tpetra::MatrixMarket::Writer< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > >::crs_graph_type const > const &pGraph,std::string const &graphName,std::string const &graphDescription,bool const debug=false){ - Tpetra::MatrixMarket::Writer::writeSparseGraphFile(filename, pGraph, graphName, graphDescription, debug); - } -SWIGINTERN void Tpetra_MatrixMarket_Writer_Sl_CMT_Sg__writeSparseGraphFile__SWIG_2(std::string const &filename,Teuchos::RCP< Tpetra::MatrixMarket::Writer< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > >::crs_graph_type const > const &pGraph,bool const debug=false){ - Tpetra::MatrixMarket::Writer::writeSparseGraphFile(filename, pGraph, debug); - } -SWIGINTERN void Tpetra_MatrixMarket_Writer_Sl_CMT_Sg__writeDenseFile__SWIG_0(std::string const &filename,Teuchos::RCP< Tpetra::MatrixMarket::Writer< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > >::multivector_type const > const &X,std::string const &matrixName,std::string const &matrixDescription){ - Tpetra::MatrixMarket::Writer::writeDenseFile(filename, X, matrixName, matrixDescription); - } -SWIGINTERN void Tpetra_MatrixMarket_Writer_Sl_CMT_Sg__writeDenseFile__SWIG_1(std::string const &filename,Teuchos::RCP< Tpetra::MatrixMarket::Writer< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > >::multivector_type const > const &X){ - Tpetra::MatrixMarket::Writer::writeDenseFile(filename, X); - } - #include "Teuchos_RCP.hpp" #include "TpetraExt_MatrixMatrix.hpp" @@ -14136,44 +14090,40 @@ SWIGEXPORT SwigClassWrapper _wrap_matrix_to_operator(SwigClassWrapper const *far } -SWIGEXPORT SwigClassWrapper _wrap_TpetraReader_readSparseGraphFile__SWIG_0(SwigArrayWrapper *farg1, SwigClassWrapper const *farg2, int const *farg3, int const *farg4, int const *farg5) { +SWIGEXPORT SwigClassWrapper _wrap_TpetraReader_readSparseGraphFile__SWIG_0(SwigArrayWrapper *farg1, SwigClassWrapper const *farg2, int const *farg3) { SwigClassWrapper fresult ; std::string *arg1 = 0 ; - Teuchos::RCP< Teuchos::Comm< int > const > *arg2 = 0 ; + Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > >::comm_type const > *arg2 = 0 ; bool arg3 ; - bool arg4 ; - bool arg5 ; std::string tempstr1 ; - Teuchos::RCP< Teuchos::Comm< int > const > tempnull2 ; - Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::sparse_graph_type > result; + Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > >::comm_type const > tempnull2 ; + Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > >::sparse_graph_type > result; tempstr1 = std::string(static_cast(farg1->data), farg1->size); arg1 = &tempstr1; - arg2 = farg2->cptr ? static_cast< Teuchos::RCP< Teuchos::Comm< int > const > * >(farg2->cptr) : &tempnull2; + arg2 = farg2->cptr ? static_cast< Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > >::comm_type const > * >(farg2->cptr) : &tempnull2; arg3 = (*farg3 ? true : false); - arg4 = (*farg4 ? true : false); - arg5 = (*farg5 ? true : false); { // Make sure no unhandled exceptions exist before performing a new action - SWIG_check_unhandled_exception_impl("Tpetra::MatrixMarket::Reader< CMT >::Tpetra_MatrixMarket_Reader_Sl_CMT_Sg__readSparseGraphFile__SWIG_0(std::string const &,Teuchos::RCP< Teuchos::Comm< int > const > const &,bool const,bool const,bool const)");; + SWIG_check_unhandled_exception_impl("Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::readSparseGraphFile(std::string const &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > >::comm_type const > const &,bool const)");; try { // Attempt the wrapped function call - result = Tpetra_MatrixMarket_Reader_Sl_CMT_Sg__readSparseGraphFile__SWIG_0((std::string const &)*arg1,(Teuchos::RCP< Teuchos::Comm< int > const > const &)*arg2,arg3,arg4,arg5); + result = Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::SWIGTEMPLATEDISAMBIGUATOR readSparseGraphFile((std::string const &)*arg1,(Teuchos::RCP< Teuchos::Comm< int > const > const &)*arg2,arg3); } catch (const std::range_error& e) { // Store a C++ exception - SWIG_exception_impl("Tpetra::MatrixMarket::Reader< CMT >::Tpetra_MatrixMarket_Reader_Sl_CMT_Sg__readSparseGraphFile__SWIG_0(std::string const &,Teuchos::RCP< Teuchos::Comm< int > const > const &,bool const,bool const,bool const)", SWIG_IndexError, e.what(), return SwigClassWrapper_uninitialized()); + SWIG_exception_impl("Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::readSparseGraphFile(std::string const &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > >::comm_type const > const &,bool const)", SWIG_IndexError, e.what(), return SwigClassWrapper_uninitialized()); } catch (const std::exception& e) { // Store a C++ exception - SWIG_exception_impl("Tpetra::MatrixMarket::Reader< CMT >::Tpetra_MatrixMarket_Reader_Sl_CMT_Sg__readSparseGraphFile__SWIG_0(std::string const &,Teuchos::RCP< Teuchos::Comm< int > const > const &,bool const,bool const,bool const)", SWIG_RuntimeError, e.what(), return SwigClassWrapper_uninitialized()); + SWIG_exception_impl("Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::readSparseGraphFile(std::string const &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > >::comm_type const > const &,bool const)", SWIG_RuntimeError, e.what(), return SwigClassWrapper_uninitialized()); } catch (...) { - SWIG_exception_impl("Tpetra::MatrixMarket::Reader< CMT >::Tpetra_MatrixMarket_Reader_Sl_CMT_Sg__readSparseGraphFile__SWIG_0(std::string const &,Teuchos::RCP< Teuchos::Comm< int > const > const &,bool const,bool const,bool const)", SWIG_UnknownError, "An unknown exception occurred", return SwigClassWrapper_uninitialized()); + SWIG_exception_impl("Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::readSparseGraphFile(std::string const &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > >::comm_type const > const &,bool const)", SWIG_UnknownError, "An unknown exception occurred", return SwigClassWrapper_uninitialized()); } } fresult.cptr = (new Teuchos::RCP< Tpetra::CrsGraph >(static_cast< const Teuchos::RCP< Tpetra::CrsGraph >& >(result))); @@ -14182,42 +14132,38 @@ SWIGEXPORT SwigClassWrapper _wrap_TpetraReader_readSparseGraphFile__SWIG_0(SwigA } -SWIGEXPORT SwigClassWrapper _wrap_TpetraReader_readSparseGraphFile__SWIG_1(SwigArrayWrapper *farg1, SwigClassWrapper const *farg2, int const *farg3, int const *farg4) { +SWIGEXPORT SwigClassWrapper _wrap_TpetraReader_readSparseGraphFile__SWIG_1(SwigArrayWrapper *farg1, SwigClassWrapper const *farg2) { SwigClassWrapper fresult ; std::string *arg1 = 0 ; - Teuchos::RCP< Teuchos::Comm< int > const > *arg2 = 0 ; - bool arg3 ; - bool arg4 ; + Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > >::comm_type const > *arg2 = 0 ; std::string tempstr1 ; - Teuchos::RCP< Teuchos::Comm< int > const > tempnull2 ; - Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::sparse_graph_type > result; + Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > >::comm_type const > tempnull2 ; + Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > >::sparse_graph_type > result; tempstr1 = std::string(static_cast(farg1->data), farg1->size); arg1 = &tempstr1; - arg2 = farg2->cptr ? static_cast< Teuchos::RCP< Teuchos::Comm< int > const > * >(farg2->cptr) : &tempnull2; - arg3 = (*farg3 ? true : false); - arg4 = (*farg4 ? true : false); + arg2 = farg2->cptr ? static_cast< Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > >::comm_type const > * >(farg2->cptr) : &tempnull2; { // Make sure no unhandled exceptions exist before performing a new action - SWIG_check_unhandled_exception_impl("Tpetra::MatrixMarket::Reader< CMT >::Tpetra_MatrixMarket_Reader_Sl_CMT_Sg__readSparseGraphFile__SWIG_0(std::string const &,Teuchos::RCP< Teuchos::Comm< int > const > const &,bool const,bool const)");; + SWIG_check_unhandled_exception_impl("Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::readSparseGraphFile(std::string const &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > >::comm_type const > const &)");; try { // Attempt the wrapped function call - result = Tpetra_MatrixMarket_Reader_Sl_CMT_Sg__readSparseGraphFile__SWIG_0((std::string const &)*arg1,(Teuchos::RCP< Teuchos::Comm< int > const > const &)*arg2,arg3,arg4); + result = Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::SWIGTEMPLATEDISAMBIGUATOR readSparseGraphFile((std::string const &)*arg1,(Teuchos::RCP< Teuchos::Comm< int > const > const &)*arg2); } catch (const std::range_error& e) { // Store a C++ exception - SWIG_exception_impl("Tpetra::MatrixMarket::Reader< CMT >::Tpetra_MatrixMarket_Reader_Sl_CMT_Sg__readSparseGraphFile__SWIG_0(std::string const &,Teuchos::RCP< Teuchos::Comm< int > const > const &,bool const,bool const)", SWIG_IndexError, e.what(), return SwigClassWrapper_uninitialized()); + SWIG_exception_impl("Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::readSparseGraphFile(std::string const &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > >::comm_type const > const &)", SWIG_IndexError, e.what(), return SwigClassWrapper_uninitialized()); } catch (const std::exception& e) { // Store a C++ exception - SWIG_exception_impl("Tpetra::MatrixMarket::Reader< CMT >::Tpetra_MatrixMarket_Reader_Sl_CMT_Sg__readSparseGraphFile__SWIG_0(std::string const &,Teuchos::RCP< Teuchos::Comm< int > const > const &,bool const,bool const)", SWIG_RuntimeError, e.what(), return SwigClassWrapper_uninitialized()); + SWIG_exception_impl("Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::readSparseGraphFile(std::string const &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > >::comm_type const > const &)", SWIG_RuntimeError, e.what(), return SwigClassWrapper_uninitialized()); } catch (...) { - SWIG_exception_impl("Tpetra::MatrixMarket::Reader< CMT >::Tpetra_MatrixMarket_Reader_Sl_CMT_Sg__readSparseGraphFile__SWIG_0(std::string const &,Teuchos::RCP< Teuchos::Comm< int > const > const &,bool const,bool const)", SWIG_UnknownError, "An unknown exception occurred", return SwigClassWrapper_uninitialized()); + SWIG_exception_impl("Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::readSparseGraphFile(std::string const &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > >::comm_type const > const &)", SWIG_UnknownError, "An unknown exception occurred", return SwigClassWrapper_uninitialized()); } } fresult.cptr = (new Teuchos::RCP< Tpetra::CrsGraph >(static_cast< const Teuchos::RCP< Tpetra::CrsGraph >& >(result))); @@ -14226,40 +14172,44 @@ SWIGEXPORT SwigClassWrapper _wrap_TpetraReader_readSparseGraphFile__SWIG_1(SwigA } -SWIGEXPORT SwigClassWrapper _wrap_TpetraReader_readSparseGraphFile__SWIG_2(SwigArrayWrapper *farg1, SwigClassWrapper const *farg2, int const *farg3) { +SWIGEXPORT SwigClassWrapper _wrap_TpetraReader_readSparseGraphFile__SWIG_2(SwigArrayWrapper *farg1, SwigClassWrapper const *farg2, SwigClassWrapper const *farg3, SwigClassWrapper const *farg4) { SwigClassWrapper fresult ; std::string *arg1 = 0 ; - Teuchos::RCP< Teuchos::Comm< int > const > *arg2 = 0 ; - bool arg3 ; + Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > >::comm_type const > *arg2 = 0 ; + Teuchos::RCP< Teuchos::ParameterList > *arg3 = 0 ; + Teuchos::RCP< Teuchos::ParameterList > *arg4 = 0 ; std::string tempstr1 ; - Teuchos::RCP< Teuchos::Comm< int > const > tempnull2 ; - Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::sparse_graph_type > result; + Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > >::comm_type const > tempnull2 ; + Teuchos::RCP< Teuchos::ParameterList > tempnull3 ; + Teuchos::RCP< Teuchos::ParameterList > tempnull4 ; + Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > >::sparse_graph_type > result; tempstr1 = std::string(static_cast(farg1->data), farg1->size); arg1 = &tempstr1; - arg2 = farg2->cptr ? static_cast< Teuchos::RCP< Teuchos::Comm< int > const > * >(farg2->cptr) : &tempnull2; - arg3 = (*farg3 ? true : false); + arg2 = farg2->cptr ? static_cast< Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > >::comm_type const > * >(farg2->cptr) : &tempnull2; + arg3 = farg3->cptr ? static_cast< Teuchos::RCP< Teuchos::ParameterList > * >(farg3->cptr) : &tempnull3; + arg4 = farg4->cptr ? static_cast< Teuchos::RCP< Teuchos::ParameterList > * >(farg4->cptr) : &tempnull4; { // Make sure no unhandled exceptions exist before performing a new action - SWIG_check_unhandled_exception_impl("Tpetra::MatrixMarket::Reader< CMT >::Tpetra_MatrixMarket_Reader_Sl_CMT_Sg__readSparseGraphFile__SWIG_0(std::string const &,Teuchos::RCP< Teuchos::Comm< int > const > const &,bool const)");; + SWIG_check_unhandled_exception_impl("Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::readSparseGraphFile(std::string const &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > >::comm_type const > const &,Teuchos::RCP< Teuchos::ParameterList > const &,Teuchos::RCP< Teuchos::ParameterList > const &)");; try { // Attempt the wrapped function call - result = Tpetra_MatrixMarket_Reader_Sl_CMT_Sg__readSparseGraphFile__SWIG_0((std::string const &)*arg1,(Teuchos::RCP< Teuchos::Comm< int > const > const &)*arg2,arg3); + result = Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::SWIGTEMPLATEDISAMBIGUATOR readSparseGraphFile((std::string const &)*arg1,(Teuchos::RCP< Teuchos::Comm< int > const > const &)*arg2,(Teuchos::RCP< Teuchos::ParameterList > const &)*arg3,(Teuchos::RCP< Teuchos::ParameterList > const &)*arg4); } catch (const std::range_error& e) { // Store a C++ exception - SWIG_exception_impl("Tpetra::MatrixMarket::Reader< CMT >::Tpetra_MatrixMarket_Reader_Sl_CMT_Sg__readSparseGraphFile__SWIG_0(std::string const &,Teuchos::RCP< Teuchos::Comm< int > const > const &,bool const)", SWIG_IndexError, e.what(), return SwigClassWrapper_uninitialized()); + SWIG_exception_impl("Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::readSparseGraphFile(std::string const &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > >::comm_type const > const &,Teuchos::RCP< Teuchos::ParameterList > const &,Teuchos::RCP< Teuchos::ParameterList > const &)", SWIG_IndexError, e.what(), return SwigClassWrapper_uninitialized()); } catch (const std::exception& e) { // Store a C++ exception - SWIG_exception_impl("Tpetra::MatrixMarket::Reader< CMT >::Tpetra_MatrixMarket_Reader_Sl_CMT_Sg__readSparseGraphFile__SWIG_0(std::string const &,Teuchos::RCP< Teuchos::Comm< int > const > const &,bool const)", SWIG_RuntimeError, e.what(), return SwigClassWrapper_uninitialized()); + SWIG_exception_impl("Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::readSparseGraphFile(std::string const &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > >::comm_type const > const &,Teuchos::RCP< Teuchos::ParameterList > const &,Teuchos::RCP< Teuchos::ParameterList > const &)", SWIG_RuntimeError, e.what(), return SwigClassWrapper_uninitialized()); } catch (...) { - SWIG_exception_impl("Tpetra::MatrixMarket::Reader< CMT >::Tpetra_MatrixMarket_Reader_Sl_CMT_Sg__readSparseGraphFile__SWIG_0(std::string const &,Teuchos::RCP< Teuchos::Comm< int > const > const &,bool const)", SWIG_UnknownError, "An unknown exception occurred", return SwigClassWrapper_uninitialized()); + SWIG_exception_impl("Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::readSparseGraphFile(std::string const &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > >::comm_type const > const &,Teuchos::RCP< Teuchos::ParameterList > const &,Teuchos::RCP< Teuchos::ParameterList > const &)", SWIG_UnknownError, "An unknown exception occurred", return SwigClassWrapper_uninitialized()); } } fresult.cptr = (new Teuchos::RCP< Tpetra::CrsGraph >(static_cast< const Teuchos::RCP< Tpetra::CrsGraph >& >(result))); @@ -14268,38 +14218,49 @@ SWIGEXPORT SwigClassWrapper _wrap_TpetraReader_readSparseGraphFile__SWIG_2(SwigA } -SWIGEXPORT SwigClassWrapper _wrap_TpetraReader_readSparseGraphFile__SWIG_3(SwigArrayWrapper *farg1, SwigClassWrapper const *farg2) { +SWIGEXPORT SwigClassWrapper _wrap_TpetraReader_readSparseGraphFile__SWIG_3(SwigArrayWrapper *farg1, SwigClassWrapper const *farg2, SwigClassWrapper const *farg3, SwigClassWrapper const *farg4, SwigClassWrapper const *farg5, int const *farg6) { SwigClassWrapper fresult ; std::string *arg1 = 0 ; - Teuchos::RCP< Teuchos::Comm< int > const > *arg2 = 0 ; + Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > >::map_type const > *arg2 = 0 ; + Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > *arg3 = 0 ; + Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > >::map_type const > *arg4 = 0 ; + Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > >::map_type const > *arg5 = 0 ; + bool arg6 ; std::string tempstr1 ; - Teuchos::RCP< Teuchos::Comm< int > const > tempnull2 ; - Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::sparse_graph_type > result; + Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > >::map_type const > tempnull2 ; + Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > tempnull3 ; + Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > >::map_type const > tempnull4 ; + Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > >::map_type const > tempnull5 ; + Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > >::sparse_graph_type > result; tempstr1 = std::string(static_cast(farg1->data), farg1->size); arg1 = &tempstr1; - arg2 = farg2->cptr ? static_cast< Teuchos::RCP< Teuchos::Comm< int > const > * >(farg2->cptr) : &tempnull2; + arg2 = farg2->cptr ? static_cast< Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > >::map_type const > * >(farg2->cptr) : &tempnull2; + arg3 = farg3->cptr ? static_cast< Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > * >(farg3->cptr) : &tempnull3; + arg4 = farg4->cptr ? static_cast< Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > >::map_type const > * >(farg4->cptr) : &tempnull4; + arg5 = farg5->cptr ? static_cast< Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > >::map_type const > * >(farg5->cptr) : &tempnull5; + arg6 = (*farg6 ? true : false); { // Make sure no unhandled exceptions exist before performing a new action - SWIG_check_unhandled_exception_impl("Tpetra::MatrixMarket::Reader< CMT >::Tpetra_MatrixMarket_Reader_Sl_CMT_Sg__readSparseGraphFile__SWIG_0(std::string const &,Teuchos::RCP< Teuchos::Comm< int > const > const &)");; + SWIG_check_unhandled_exception_impl("Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::readSparseGraphFile(std::string const &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > >::map_type const > const &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > >::map_type const > const &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > >::map_type const > const &,bool const)");; try { // Attempt the wrapped function call - result = Tpetra_MatrixMarket_Reader_Sl_CMT_Sg__readSparseGraphFile__SWIG_0((std::string const &)*arg1,(Teuchos::RCP< Teuchos::Comm< int > const > const &)*arg2); + result = Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::SWIGTEMPLATEDISAMBIGUATOR readSparseGraphFile((std::string const &)*arg1,(Teuchos::RCP< Tpetra::Map< int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const > const &)*arg2,*arg3,(Teuchos::RCP< Tpetra::Map< int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const > const &)*arg4,(Teuchos::RCP< Tpetra::Map< int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const > const &)*arg5,arg6); } catch (const std::range_error& e) { // Store a C++ exception - SWIG_exception_impl("Tpetra::MatrixMarket::Reader< CMT >::Tpetra_MatrixMarket_Reader_Sl_CMT_Sg__readSparseGraphFile__SWIG_0(std::string const &,Teuchos::RCP< Teuchos::Comm< int > const > const &)", SWIG_IndexError, e.what(), return SwigClassWrapper_uninitialized()); + SWIG_exception_impl("Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::readSparseGraphFile(std::string const &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > >::map_type const > const &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > >::map_type const > const &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > >::map_type const > const &,bool const)", SWIG_IndexError, e.what(), return SwigClassWrapper_uninitialized()); } catch (const std::exception& e) { // Store a C++ exception - SWIG_exception_impl("Tpetra::MatrixMarket::Reader< CMT >::Tpetra_MatrixMarket_Reader_Sl_CMT_Sg__readSparseGraphFile__SWIG_0(std::string const &,Teuchos::RCP< Teuchos::Comm< int > const > const &)", SWIG_RuntimeError, e.what(), return SwigClassWrapper_uninitialized()); + SWIG_exception_impl("Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::readSparseGraphFile(std::string const &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > >::map_type const > const &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > >::map_type const > const &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > >::map_type const > const &,bool const)", SWIG_RuntimeError, e.what(), return SwigClassWrapper_uninitialized()); } catch (...) { - SWIG_exception_impl("Tpetra::MatrixMarket::Reader< CMT >::Tpetra_MatrixMarket_Reader_Sl_CMT_Sg__readSparseGraphFile__SWIG_0(std::string const &,Teuchos::RCP< Teuchos::Comm< int > const > const &)", SWIG_UnknownError, "An unknown exception occurred", return SwigClassWrapper_uninitialized()); + SWIG_exception_impl("Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::readSparseGraphFile(std::string const &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > >::map_type const > const &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > >::map_type const > const &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > >::map_type const > const &,bool const)", SWIG_UnknownError, "An unknown exception occurred", return SwigClassWrapper_uninitialized()); } } fresult.cptr = (new Teuchos::RCP< Tpetra::CrsGraph >(static_cast< const Teuchos::RCP< Tpetra::CrsGraph >& >(result))); @@ -14308,48 +14269,47 @@ SWIGEXPORT SwigClassWrapper _wrap_TpetraReader_readSparseGraphFile__SWIG_3(SwigA } -SWIGEXPORT SwigClassWrapper _wrap_TpetraReader_readSparseGraphFile__SWIG_4(SwigArrayWrapper *farg1, SwigClassWrapper const *farg2, SwigClassWrapper const *farg3, SwigClassWrapper const *farg4, int const *farg5, int const *farg6) { +SWIGEXPORT SwigClassWrapper _wrap_TpetraReader_readSparseGraphFile__SWIG_4(SwigArrayWrapper *farg1, SwigClassWrapper const *farg2, SwigClassWrapper const *farg3, SwigClassWrapper const *farg4, SwigClassWrapper const *farg5) { SwigClassWrapper fresult ; std::string *arg1 = 0 ; - Teuchos::RCP< Teuchos::Comm< int > const > *arg2 = 0 ; - Teuchos::RCP< Teuchos::ParameterList > *arg3 = 0 ; - Teuchos::RCP< Teuchos::ParameterList > *arg4 = 0 ; - bool arg5 ; - bool arg6 ; + Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > >::map_type const > *arg2 = 0 ; + Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > *arg3 = 0 ; + Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > >::map_type const > *arg4 = 0 ; + Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > >::map_type const > *arg5 = 0 ; std::string tempstr1 ; - Teuchos::RCP< Teuchos::Comm< int > const > tempnull2 ; - Teuchos::RCP< Teuchos::ParameterList > tempnull3 ; - Teuchos::RCP< Teuchos::ParameterList > tempnull4 ; - Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::sparse_graph_type > result; + Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > >::map_type const > tempnull2 ; + Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > tempnull3 ; + Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > >::map_type const > tempnull4 ; + Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > >::map_type const > tempnull5 ; + Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > >::sparse_graph_type > result; tempstr1 = std::string(static_cast(farg1->data), farg1->size); arg1 = &tempstr1; - arg2 = farg2->cptr ? static_cast< Teuchos::RCP< Teuchos::Comm< int > const > * >(farg2->cptr) : &tempnull2; - arg3 = farg3->cptr ? static_cast< Teuchos::RCP< Teuchos::ParameterList > * >(farg3->cptr) : &tempnull3; - arg4 = farg4->cptr ? static_cast< Teuchos::RCP< Teuchos::ParameterList > * >(farg4->cptr) : &tempnull4; - arg5 = (*farg5 ? true : false); - arg6 = (*farg6 ? true : false); + arg2 = farg2->cptr ? static_cast< Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > >::map_type const > * >(farg2->cptr) : &tempnull2; + arg3 = farg3->cptr ? static_cast< Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > * >(farg3->cptr) : &tempnull3; + arg4 = farg4->cptr ? static_cast< Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > >::map_type const > * >(farg4->cptr) : &tempnull4; + arg5 = farg5->cptr ? static_cast< Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > >::map_type const > * >(farg5->cptr) : &tempnull5; { // Make sure no unhandled exceptions exist before performing a new action - SWIG_check_unhandled_exception_impl("Tpetra::MatrixMarket::Reader< CMT >::Tpetra_MatrixMarket_Reader_Sl_CMT_Sg__readSparseGraphFile__SWIG_4(std::string const &,Teuchos::RCP< Teuchos::Comm< int > const > const &,Teuchos::RCP< Teuchos::ParameterList > const &,Teuchos::RCP< Teuchos::ParameterList > const &,bool const,bool const)");; + SWIG_check_unhandled_exception_impl("Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::readSparseGraphFile(std::string const &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > >::map_type const > const &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > >::map_type const > const &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > >::map_type const > const &)");; try { // Attempt the wrapped function call - result = Tpetra_MatrixMarket_Reader_Sl_CMT_Sg__readSparseGraphFile__SWIG_4((std::string const &)*arg1,(Teuchos::RCP< Teuchos::Comm< int > const > const &)*arg2,(Teuchos::RCP< Teuchos::ParameterList > const &)*arg3,(Teuchos::RCP< Teuchos::ParameterList > const &)*arg4,arg5,arg6); + result = Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::SWIGTEMPLATEDISAMBIGUATOR readSparseGraphFile((std::string const &)*arg1,(Teuchos::RCP< Tpetra::Map< int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const > const &)*arg2,*arg3,(Teuchos::RCP< Tpetra::Map< int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const > const &)*arg4,(Teuchos::RCP< Tpetra::Map< int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const > const &)*arg5); } catch (const std::range_error& e) { // Store a C++ exception - SWIG_exception_impl("Tpetra::MatrixMarket::Reader< CMT >::Tpetra_MatrixMarket_Reader_Sl_CMT_Sg__readSparseGraphFile__SWIG_4(std::string const &,Teuchos::RCP< Teuchos::Comm< int > const > const &,Teuchos::RCP< Teuchos::ParameterList > const &,Teuchos::RCP< Teuchos::ParameterList > const &,bool const,bool const)", SWIG_IndexError, e.what(), return SwigClassWrapper_uninitialized()); + SWIG_exception_impl("Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::readSparseGraphFile(std::string const &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > >::map_type const > const &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > >::map_type const > const &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > >::map_type const > const &)", SWIG_IndexError, e.what(), return SwigClassWrapper_uninitialized()); } catch (const std::exception& e) { // Store a C++ exception - SWIG_exception_impl("Tpetra::MatrixMarket::Reader< CMT >::Tpetra_MatrixMarket_Reader_Sl_CMT_Sg__readSparseGraphFile__SWIG_4(std::string const &,Teuchos::RCP< Teuchos::Comm< int > const > const &,Teuchos::RCP< Teuchos::ParameterList > const &,Teuchos::RCP< Teuchos::ParameterList > const &,bool const,bool const)", SWIG_RuntimeError, e.what(), return SwigClassWrapper_uninitialized()); + SWIG_exception_impl("Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::readSparseGraphFile(std::string const &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > >::map_type const > const &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > >::map_type const > const &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > >::map_type const > const &)", SWIG_RuntimeError, e.what(), return SwigClassWrapper_uninitialized()); } catch (...) { - SWIG_exception_impl("Tpetra::MatrixMarket::Reader< CMT >::Tpetra_MatrixMarket_Reader_Sl_CMT_Sg__readSparseGraphFile__SWIG_4(std::string const &,Teuchos::RCP< Teuchos::Comm< int > const > const &,Teuchos::RCP< Teuchos::ParameterList > const &,Teuchos::RCP< Teuchos::ParameterList > const &,bool const,bool const)", SWIG_UnknownError, "An unknown exception occurred", return SwigClassWrapper_uninitialized()); + SWIG_exception_impl("Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::readSparseGraphFile(std::string const &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > >::map_type const > const &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > >::map_type const > const &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > >::map_type const > const &)", SWIG_UnknownError, "An unknown exception occurred", return SwigClassWrapper_uninitialized()); } } fresult.cptr = (new Teuchos::RCP< Tpetra::CrsGraph >(static_cast< const Teuchos::RCP< Tpetra::CrsGraph >& >(result))); @@ -14358,1571 +14318,556 @@ SWIGEXPORT SwigClassWrapper _wrap_TpetraReader_readSparseGraphFile__SWIG_4(SwigA } -SWIGEXPORT SwigClassWrapper _wrap_TpetraReader_readSparseGraphFile__SWIG_5(SwigArrayWrapper *farg1, SwigClassWrapper const *farg2, SwigClassWrapper const *farg3, SwigClassWrapper const *farg4, int const *farg5) { +SWIGEXPORT SwigClassWrapper _wrap_TpetraReader_readSparseFile__SWIG_0(SwigArrayWrapper *farg1, SwigClassWrapper const *farg2, int const *farg3) { SwigClassWrapper fresult ; std::string *arg1 = 0 ; - Teuchos::RCP< Teuchos::Comm< int > const > *arg2 = 0 ; - Teuchos::RCP< Teuchos::ParameterList > *arg3 = 0 ; - Teuchos::RCP< Teuchos::ParameterList > *arg4 = 0 ; - bool arg5 ; + Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > >::comm_type const > *arg2 = 0 ; + bool arg3 ; std::string tempstr1 ; - Teuchos::RCP< Teuchos::Comm< int > const > tempnull2 ; - Teuchos::RCP< Teuchos::ParameterList > tempnull3 ; - Teuchos::RCP< Teuchos::ParameterList > tempnull4 ; - Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::sparse_graph_type > result; + Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > >::comm_type const > tempnull2 ; + Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > >::sparse_matrix_type > result; tempstr1 = std::string(static_cast(farg1->data), farg1->size); arg1 = &tempstr1; - arg2 = farg2->cptr ? static_cast< Teuchos::RCP< Teuchos::Comm< int > const > * >(farg2->cptr) : &tempnull2; - arg3 = farg3->cptr ? static_cast< Teuchos::RCP< Teuchos::ParameterList > * >(farg3->cptr) : &tempnull3; - arg4 = farg4->cptr ? static_cast< Teuchos::RCP< Teuchos::ParameterList > * >(farg4->cptr) : &tempnull4; - arg5 = (*farg5 ? true : false); + arg2 = farg2->cptr ? static_cast< Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > >::comm_type const > * >(farg2->cptr) : &tempnull2; + arg3 = (*farg3 ? true : false); { // Make sure no unhandled exceptions exist before performing a new action - SWIG_check_unhandled_exception_impl("Tpetra::MatrixMarket::Reader< CMT >::Tpetra_MatrixMarket_Reader_Sl_CMT_Sg__readSparseGraphFile__SWIG_4(std::string const &,Teuchos::RCP< Teuchos::Comm< int > const > const &,Teuchos::RCP< Teuchos::ParameterList > const &,Teuchos::RCP< Teuchos::ParameterList > const &,bool const)");; + SWIG_check_unhandled_exception_impl("Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::readSparseFile(std::string const &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > >::comm_type const > const &,bool const)");; try { // Attempt the wrapped function call - result = Tpetra_MatrixMarket_Reader_Sl_CMT_Sg__readSparseGraphFile__SWIG_4((std::string const &)*arg1,(Teuchos::RCP< Teuchos::Comm< int > const > const &)*arg2,(Teuchos::RCP< Teuchos::ParameterList > const &)*arg3,(Teuchos::RCP< Teuchos::ParameterList > const &)*arg4,arg5); + result = Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::SWIGTEMPLATEDISAMBIGUATOR readSparseFile((std::string const &)*arg1,(Teuchos::RCP< Teuchos::Comm< int > const > const &)*arg2,arg3); } catch (const std::range_error& e) { // Store a C++ exception - SWIG_exception_impl("Tpetra::MatrixMarket::Reader< CMT >::Tpetra_MatrixMarket_Reader_Sl_CMT_Sg__readSparseGraphFile__SWIG_4(std::string const &,Teuchos::RCP< Teuchos::Comm< int > const > const &,Teuchos::RCP< Teuchos::ParameterList > const &,Teuchos::RCP< Teuchos::ParameterList > const &,bool const)", SWIG_IndexError, e.what(), return SwigClassWrapper_uninitialized()); + SWIG_exception_impl("Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::readSparseFile(std::string const &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > >::comm_type const > const &,bool const)", SWIG_IndexError, e.what(), return SwigClassWrapper_uninitialized()); } catch (const std::exception& e) { // Store a C++ exception - SWIG_exception_impl("Tpetra::MatrixMarket::Reader< CMT >::Tpetra_MatrixMarket_Reader_Sl_CMT_Sg__readSparseGraphFile__SWIG_4(std::string const &,Teuchos::RCP< Teuchos::Comm< int > const > const &,Teuchos::RCP< Teuchos::ParameterList > const &,Teuchos::RCP< Teuchos::ParameterList > const &,bool const)", SWIG_RuntimeError, e.what(), return SwigClassWrapper_uninitialized()); + SWIG_exception_impl("Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::readSparseFile(std::string const &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > >::comm_type const > const &,bool const)", SWIG_RuntimeError, e.what(), return SwigClassWrapper_uninitialized()); } catch (...) { - SWIG_exception_impl("Tpetra::MatrixMarket::Reader< CMT >::Tpetra_MatrixMarket_Reader_Sl_CMT_Sg__readSparseGraphFile__SWIG_4(std::string const &,Teuchos::RCP< Teuchos::Comm< int > const > const &,Teuchos::RCP< Teuchos::ParameterList > const &,Teuchos::RCP< Teuchos::ParameterList > const &,bool const)", SWIG_UnknownError, "An unknown exception occurred", return SwigClassWrapper_uninitialized()); + SWIG_exception_impl("Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::readSparseFile(std::string const &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > >::comm_type const > const &,bool const)", SWIG_UnknownError, "An unknown exception occurred", return SwigClassWrapper_uninitialized()); } } - fresult.cptr = (new Teuchos::RCP< Tpetra::CrsGraph >(static_cast< const Teuchos::RCP< Tpetra::CrsGraph >& >(result))); + fresult.cptr = (new Teuchos::RCP< Tpetra::CrsMatrix >(static_cast< const Teuchos::RCP< Tpetra::CrsMatrix >& >(result))); fresult.mem = SWIG_MOVE; return fresult; } -SWIGEXPORT SwigClassWrapper _wrap_TpetraReader_readSparseGraphFile__SWIG_6(SwigArrayWrapper *farg1, SwigClassWrapper const *farg2, SwigClassWrapper const *farg3, SwigClassWrapper const *farg4) { +SWIGEXPORT SwigClassWrapper _wrap_TpetraReader_readSparseFile__SWIG_1(SwigArrayWrapper *farg1, SwigClassWrapper const *farg2) { SwigClassWrapper fresult ; std::string *arg1 = 0 ; - Teuchos::RCP< Teuchos::Comm< int > const > *arg2 = 0 ; - Teuchos::RCP< Teuchos::ParameterList > *arg3 = 0 ; - Teuchos::RCP< Teuchos::ParameterList > *arg4 = 0 ; + Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > >::comm_type const > *arg2 = 0 ; std::string tempstr1 ; - Teuchos::RCP< Teuchos::Comm< int > const > tempnull2 ; - Teuchos::RCP< Teuchos::ParameterList > tempnull3 ; - Teuchos::RCP< Teuchos::ParameterList > tempnull4 ; - Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::sparse_graph_type > result; + Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > >::comm_type const > tempnull2 ; + Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > >::sparse_matrix_type > result; tempstr1 = std::string(static_cast(farg1->data), farg1->size); arg1 = &tempstr1; - arg2 = farg2->cptr ? static_cast< Teuchos::RCP< Teuchos::Comm< int > const > * >(farg2->cptr) : &tempnull2; - arg3 = farg3->cptr ? static_cast< Teuchos::RCP< Teuchos::ParameterList > * >(farg3->cptr) : &tempnull3; - arg4 = farg4->cptr ? static_cast< Teuchos::RCP< Teuchos::ParameterList > * >(farg4->cptr) : &tempnull4; + arg2 = farg2->cptr ? static_cast< Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > >::comm_type const > * >(farg2->cptr) : &tempnull2; { // Make sure no unhandled exceptions exist before performing a new action - SWIG_check_unhandled_exception_impl("Tpetra::MatrixMarket::Reader< CMT >::Tpetra_MatrixMarket_Reader_Sl_CMT_Sg__readSparseGraphFile__SWIG_4(std::string const &,Teuchos::RCP< Teuchos::Comm< int > const > const &,Teuchos::RCP< Teuchos::ParameterList > const &,Teuchos::RCP< Teuchos::ParameterList > const &)");; + SWIG_check_unhandled_exception_impl("Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::readSparseFile(std::string const &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > >::comm_type const > const &)");; try { // Attempt the wrapped function call - result = Tpetra_MatrixMarket_Reader_Sl_CMT_Sg__readSparseGraphFile__SWIG_4((std::string const &)*arg1,(Teuchos::RCP< Teuchos::Comm< int > const > const &)*arg2,(Teuchos::RCP< Teuchos::ParameterList > const &)*arg3,(Teuchos::RCP< Teuchos::ParameterList > const &)*arg4); + result = Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::SWIGTEMPLATEDISAMBIGUATOR readSparseFile((std::string const &)*arg1,(Teuchos::RCP< Teuchos::Comm< int > const > const &)*arg2); } catch (const std::range_error& e) { // Store a C++ exception - SWIG_exception_impl("Tpetra::MatrixMarket::Reader< CMT >::Tpetra_MatrixMarket_Reader_Sl_CMT_Sg__readSparseGraphFile__SWIG_4(std::string const &,Teuchos::RCP< Teuchos::Comm< int > const > const &,Teuchos::RCP< Teuchos::ParameterList > const &,Teuchos::RCP< Teuchos::ParameterList > const &)", SWIG_IndexError, e.what(), return SwigClassWrapper_uninitialized()); + SWIG_exception_impl("Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::readSparseFile(std::string const &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > >::comm_type const > const &)", SWIG_IndexError, e.what(), return SwigClassWrapper_uninitialized()); } catch (const std::exception& e) { // Store a C++ exception - SWIG_exception_impl("Tpetra::MatrixMarket::Reader< CMT >::Tpetra_MatrixMarket_Reader_Sl_CMT_Sg__readSparseGraphFile__SWIG_4(std::string const &,Teuchos::RCP< Teuchos::Comm< int > const > const &,Teuchos::RCP< Teuchos::ParameterList > const &,Teuchos::RCP< Teuchos::ParameterList > const &)", SWIG_RuntimeError, e.what(), return SwigClassWrapper_uninitialized()); + SWIG_exception_impl("Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::readSparseFile(std::string const &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > >::comm_type const > const &)", SWIG_RuntimeError, e.what(), return SwigClassWrapper_uninitialized()); } catch (...) { - SWIG_exception_impl("Tpetra::MatrixMarket::Reader< CMT >::Tpetra_MatrixMarket_Reader_Sl_CMT_Sg__readSparseGraphFile__SWIG_4(std::string const &,Teuchos::RCP< Teuchos::Comm< int > const > const &,Teuchos::RCP< Teuchos::ParameterList > const &,Teuchos::RCP< Teuchos::ParameterList > const &)", SWIG_UnknownError, "An unknown exception occurred", return SwigClassWrapper_uninitialized()); + SWIG_exception_impl("Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::readSparseFile(std::string const &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > >::comm_type const > const &)", SWIG_UnknownError, "An unknown exception occurred", return SwigClassWrapper_uninitialized()); } } - fresult.cptr = (new Teuchos::RCP< Tpetra::CrsGraph >(static_cast< const Teuchos::RCP< Tpetra::CrsGraph >& >(result))); + fresult.cptr = (new Teuchos::RCP< Tpetra::CrsMatrix >(static_cast< const Teuchos::RCP< Tpetra::CrsMatrix >& >(result))); fresult.mem = SWIG_MOVE; return fresult; } -SWIGEXPORT SwigClassWrapper _wrap_TpetraReader_readSparseGraphFile__SWIG_7(SwigArrayWrapper *farg1, SwigClassWrapper const *farg2, SwigClassWrapper const *farg3, SwigClassWrapper const *farg4, SwigClassWrapper const *farg5, int const *farg6, int const *farg7, int const *farg8) { +SWIGEXPORT SwigClassWrapper _wrap_TpetraReader_readSparseFile__SWIG_2(SwigArrayWrapper *farg1, SwigClassWrapper const *farg2, SwigClassWrapper const *farg3, SwigClassWrapper const *farg4) { SwigClassWrapper fresult ; std::string *arg1 = 0 ; - Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > *arg2 = 0 ; - Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > *arg3 = 0 ; - Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > *arg4 = 0 ; - Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > *arg5 = 0 ; - bool arg6 ; - bool arg7 ; - bool arg8 ; + Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > >::comm_type const > *arg2 = 0 ; + Teuchos::RCP< Teuchos::ParameterList > *arg3 = 0 ; + Teuchos::RCP< Teuchos::ParameterList > *arg4 = 0 ; std::string tempstr1 ; - Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > tempnull2 ; - Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > tempnull3 ; - Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > tempnull4 ; - Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > tempnull5 ; - Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::sparse_graph_type > result; + Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > >::comm_type const > tempnull2 ; + Teuchos::RCP< Teuchos::ParameterList > tempnull3 ; + Teuchos::RCP< Teuchos::ParameterList > tempnull4 ; + Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > >::sparse_matrix_type > result; tempstr1 = std::string(static_cast(farg1->data), farg1->size); arg1 = &tempstr1; - arg2 = farg2->cptr ? static_cast< Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > * >(farg2->cptr) : &tempnull2; - arg3 = farg3->cptr ? static_cast< Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > * >(farg3->cptr) : &tempnull3; - arg4 = farg4->cptr ? static_cast< Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > * >(farg4->cptr) : &tempnull4; - arg5 = farg5->cptr ? static_cast< Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > * >(farg5->cptr) : &tempnull5; - arg6 = (*farg6 ? true : false); - arg7 = (*farg7 ? true : false); - arg8 = (*farg8 ? true : false); + arg2 = farg2->cptr ? static_cast< Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > >::comm_type const > * >(farg2->cptr) : &tempnull2; + arg3 = farg3->cptr ? static_cast< Teuchos::RCP< Teuchos::ParameterList > * >(farg3->cptr) : &tempnull3; + arg4 = farg4->cptr ? static_cast< Teuchos::RCP< Teuchos::ParameterList > * >(farg4->cptr) : &tempnull4; { // Make sure no unhandled exceptions exist before performing a new action - SWIG_check_unhandled_exception_impl("Tpetra::MatrixMarket::Reader< CMT >::Tpetra_MatrixMarket_Reader_Sl_CMT_Sg__readSparseGraphFile__SWIG_7(std::string const &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > const &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > const &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > const &,bool const,bool const,bool const)");; + SWIG_check_unhandled_exception_impl("Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::readSparseFile(std::string const &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > >::comm_type const > const &,Teuchos::RCP< Teuchos::ParameterList > const &,Teuchos::RCP< Teuchos::ParameterList > const &)");; try { // Attempt the wrapped function call - result = Tpetra_MatrixMarket_Reader_Sl_CMT_Sg__readSparseGraphFile__SWIG_7((std::string const &)*arg1,(Teuchos::RCP< Tpetra::Map< int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const > const &)*arg2,*arg3,(Teuchos::RCP< Tpetra::Map< int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const > const &)*arg4,(Teuchos::RCP< Tpetra::Map< int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const > const &)*arg5,arg6,arg7,arg8); + result = Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::SWIGTEMPLATEDISAMBIGUATOR readSparseFile((std::string const &)*arg1,(Teuchos::RCP< Teuchos::Comm< int > const > const &)*arg2,(Teuchos::RCP< Teuchos::ParameterList > const &)*arg3,(Teuchos::RCP< Teuchos::ParameterList > const &)*arg4); } catch (const std::range_error& e) { // Store a C++ exception - SWIG_exception_impl("Tpetra::MatrixMarket::Reader< CMT >::Tpetra_MatrixMarket_Reader_Sl_CMT_Sg__readSparseGraphFile__SWIG_7(std::string const &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > const &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > const &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > const &,bool const,bool const,bool const)", SWIG_IndexError, e.what(), return SwigClassWrapper_uninitialized()); + SWIG_exception_impl("Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::readSparseFile(std::string const &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > >::comm_type const > const &,Teuchos::RCP< Teuchos::ParameterList > const &,Teuchos::RCP< Teuchos::ParameterList > const &)", SWIG_IndexError, e.what(), return SwigClassWrapper_uninitialized()); } catch (const std::exception& e) { // Store a C++ exception - SWIG_exception_impl("Tpetra::MatrixMarket::Reader< CMT >::Tpetra_MatrixMarket_Reader_Sl_CMT_Sg__readSparseGraphFile__SWIG_7(std::string const &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > const &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > const &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > const &,bool const,bool const,bool const)", SWIG_RuntimeError, e.what(), return SwigClassWrapper_uninitialized()); + SWIG_exception_impl("Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::readSparseFile(std::string const &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > >::comm_type const > const &,Teuchos::RCP< Teuchos::ParameterList > const &,Teuchos::RCP< Teuchos::ParameterList > const &)", SWIG_RuntimeError, e.what(), return SwigClassWrapper_uninitialized()); } catch (...) { - SWIG_exception_impl("Tpetra::MatrixMarket::Reader< CMT >::Tpetra_MatrixMarket_Reader_Sl_CMT_Sg__readSparseGraphFile__SWIG_7(std::string const &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > const &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > const &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > const &,bool const,bool const,bool const)", SWIG_UnknownError, "An unknown exception occurred", return SwigClassWrapper_uninitialized()); + SWIG_exception_impl("Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::readSparseFile(std::string const &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > >::comm_type const > const &,Teuchos::RCP< Teuchos::ParameterList > const &,Teuchos::RCP< Teuchos::ParameterList > const &)", SWIG_UnknownError, "An unknown exception occurred", return SwigClassWrapper_uninitialized()); } } - fresult.cptr = (new Teuchos::RCP< Tpetra::CrsGraph >(static_cast< const Teuchos::RCP< Tpetra::CrsGraph >& >(result))); + fresult.cptr = (new Teuchos::RCP< Tpetra::CrsMatrix >(static_cast< const Teuchos::RCP< Tpetra::CrsMatrix >& >(result))); fresult.mem = SWIG_MOVE; return fresult; } -SWIGEXPORT SwigClassWrapper _wrap_TpetraReader_readSparseGraphFile__SWIG_8(SwigArrayWrapper *farg1, SwigClassWrapper const *farg2, SwigClassWrapper const *farg3, SwigClassWrapper const *farg4, SwigClassWrapper const *farg5, int const *farg6, int const *farg7) { +SWIGEXPORT SwigClassWrapper _wrap_TpetraReader_readSparseFile__SWIG_3(SwigArrayWrapper *farg1, SwigClassWrapper const *farg2, SwigClassWrapper const *farg3, SwigClassWrapper const *farg4, SwigClassWrapper const *farg5, int const *farg6) { SwigClassWrapper fresult ; std::string *arg1 = 0 ; - Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > *arg2 = 0 ; + Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > >::map_type const > *arg2 = 0 ; Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > *arg3 = 0 ; - Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > *arg4 = 0 ; - Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > *arg5 = 0 ; + Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > >::map_type const > *arg4 = 0 ; + Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > >::map_type const > *arg5 = 0 ; bool arg6 ; - bool arg7 ; std::string tempstr1 ; - Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > tempnull2 ; + Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > >::map_type const > tempnull2 ; Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > tempnull3 ; - Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > tempnull4 ; - Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > tempnull5 ; - Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::sparse_graph_type > result; + Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > >::map_type const > tempnull4 ; + Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > >::map_type const > tempnull5 ; + Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > >::sparse_matrix_type > result; tempstr1 = std::string(static_cast(farg1->data), farg1->size); arg1 = &tempstr1; - arg2 = farg2->cptr ? static_cast< Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > * >(farg2->cptr) : &tempnull2; + arg2 = farg2->cptr ? static_cast< Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > >::map_type const > * >(farg2->cptr) : &tempnull2; arg3 = farg3->cptr ? static_cast< Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > * >(farg3->cptr) : &tempnull3; - arg4 = farg4->cptr ? static_cast< Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > * >(farg4->cptr) : &tempnull4; - arg5 = farg5->cptr ? static_cast< Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > * >(farg5->cptr) : &tempnull5; + arg4 = farg4->cptr ? static_cast< Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > >::map_type const > * >(farg4->cptr) : &tempnull4; + arg5 = farg5->cptr ? static_cast< Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > >::map_type const > * >(farg5->cptr) : &tempnull5; arg6 = (*farg6 ? true : false); - arg7 = (*farg7 ? true : false); { // Make sure no unhandled exceptions exist before performing a new action - SWIG_check_unhandled_exception_impl("Tpetra::MatrixMarket::Reader< CMT >::Tpetra_MatrixMarket_Reader_Sl_CMT_Sg__readSparseGraphFile__SWIG_7(std::string const &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > const &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > const &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > const &,bool const,bool const)");; + SWIG_check_unhandled_exception_impl("Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::readSparseFile(std::string const &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > >::map_type const > const &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > >::map_type const > const &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > >::map_type const > const &,bool const)");; try { // Attempt the wrapped function call - result = Tpetra_MatrixMarket_Reader_Sl_CMT_Sg__readSparseGraphFile__SWIG_7((std::string const &)*arg1,(Teuchos::RCP< Tpetra::Map< int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const > const &)*arg2,*arg3,(Teuchos::RCP< Tpetra::Map< int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const > const &)*arg4,(Teuchos::RCP< Tpetra::Map< int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const > const &)*arg5,arg6,arg7); + result = Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::SWIGTEMPLATEDISAMBIGUATOR readSparseFile((std::string const &)*arg1,(Teuchos::RCP< Tpetra::Map< int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const > const &)*arg2,*arg3,(Teuchos::RCP< Tpetra::Map< int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const > const &)*arg4,(Teuchos::RCP< Tpetra::Map< int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const > const &)*arg5,arg6); } catch (const std::range_error& e) { // Store a C++ exception - SWIG_exception_impl("Tpetra::MatrixMarket::Reader< CMT >::Tpetra_MatrixMarket_Reader_Sl_CMT_Sg__readSparseGraphFile__SWIG_7(std::string const &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > const &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > const &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > const &,bool const,bool const)", SWIG_IndexError, e.what(), return SwigClassWrapper_uninitialized()); + SWIG_exception_impl("Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::readSparseFile(std::string const &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > >::map_type const > const &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > >::map_type const > const &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > >::map_type const > const &,bool const)", SWIG_IndexError, e.what(), return SwigClassWrapper_uninitialized()); } catch (const std::exception& e) { // Store a C++ exception - SWIG_exception_impl("Tpetra::MatrixMarket::Reader< CMT >::Tpetra_MatrixMarket_Reader_Sl_CMT_Sg__readSparseGraphFile__SWIG_7(std::string const &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > const &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > const &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > const &,bool const,bool const)", SWIG_RuntimeError, e.what(), return SwigClassWrapper_uninitialized()); + SWIG_exception_impl("Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::readSparseFile(std::string const &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > >::map_type const > const &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > >::map_type const > const &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > >::map_type const > const &,bool const)", SWIG_RuntimeError, e.what(), return SwigClassWrapper_uninitialized()); } catch (...) { - SWIG_exception_impl("Tpetra::MatrixMarket::Reader< CMT >::Tpetra_MatrixMarket_Reader_Sl_CMT_Sg__readSparseGraphFile__SWIG_7(std::string const &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > const &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > const &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > const &,bool const,bool const)", SWIG_UnknownError, "An unknown exception occurred", return SwigClassWrapper_uninitialized()); + SWIG_exception_impl("Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::readSparseFile(std::string const &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > >::map_type const > const &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > >::map_type const > const &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > >::map_type const > const &,bool const)", SWIG_UnknownError, "An unknown exception occurred", return SwigClassWrapper_uninitialized()); } } - fresult.cptr = (new Teuchos::RCP< Tpetra::CrsGraph >(static_cast< const Teuchos::RCP< Tpetra::CrsGraph >& >(result))); + fresult.cptr = (new Teuchos::RCP< Tpetra::CrsMatrix >(static_cast< const Teuchos::RCP< Tpetra::CrsMatrix >& >(result))); fresult.mem = SWIG_MOVE; return fresult; } -SWIGEXPORT SwigClassWrapper _wrap_TpetraReader_readSparseGraphFile__SWIG_9(SwigArrayWrapper *farg1, SwigClassWrapper const *farg2, SwigClassWrapper const *farg3, SwigClassWrapper const *farg4, SwigClassWrapper const *farg5, int const *farg6) { +SWIGEXPORT SwigClassWrapper _wrap_TpetraReader_readSparseFile__SWIG_4(SwigArrayWrapper *farg1, SwigClassWrapper const *farg2, SwigClassWrapper const *farg3, SwigClassWrapper const *farg4, SwigClassWrapper const *farg5) { SwigClassWrapper fresult ; std::string *arg1 = 0 ; - Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > *arg2 = 0 ; + Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > >::map_type const > *arg2 = 0 ; Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > *arg3 = 0 ; - Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > *arg4 = 0 ; - Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > *arg5 = 0 ; - bool arg6 ; + Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > >::map_type const > *arg4 = 0 ; + Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > >::map_type const > *arg5 = 0 ; std::string tempstr1 ; - Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > tempnull2 ; + Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > >::map_type const > tempnull2 ; Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > tempnull3 ; - Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > tempnull4 ; - Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > tempnull5 ; - Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::sparse_graph_type > result; + Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > >::map_type const > tempnull4 ; + Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > >::map_type const > tempnull5 ; + Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > >::sparse_matrix_type > result; tempstr1 = std::string(static_cast(farg1->data), farg1->size); arg1 = &tempstr1; - arg2 = farg2->cptr ? static_cast< Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > * >(farg2->cptr) : &tempnull2; + arg2 = farg2->cptr ? static_cast< Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > >::map_type const > * >(farg2->cptr) : &tempnull2; arg3 = farg3->cptr ? static_cast< Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > * >(farg3->cptr) : &tempnull3; - arg4 = farg4->cptr ? static_cast< Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > * >(farg4->cptr) : &tempnull4; - arg5 = farg5->cptr ? static_cast< Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > * >(farg5->cptr) : &tempnull5; - arg6 = (*farg6 ? true : false); + arg4 = farg4->cptr ? static_cast< Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > >::map_type const > * >(farg4->cptr) : &tempnull4; + arg5 = farg5->cptr ? static_cast< Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > >::map_type const > * >(farg5->cptr) : &tempnull5; { // Make sure no unhandled exceptions exist before performing a new action - SWIG_check_unhandled_exception_impl("Tpetra::MatrixMarket::Reader< CMT >::Tpetra_MatrixMarket_Reader_Sl_CMT_Sg__readSparseGraphFile__SWIG_7(std::string const &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > const &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > const &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > const &,bool const)");; + SWIG_check_unhandled_exception_impl("Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::readSparseFile(std::string const &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > >::map_type const > const &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > >::map_type const > const &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > >::map_type const > const &)");; try { // Attempt the wrapped function call - result = Tpetra_MatrixMarket_Reader_Sl_CMT_Sg__readSparseGraphFile__SWIG_7((std::string const &)*arg1,(Teuchos::RCP< Tpetra::Map< int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const > const &)*arg2,*arg3,(Teuchos::RCP< Tpetra::Map< int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const > const &)*arg4,(Teuchos::RCP< Tpetra::Map< int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const > const &)*arg5,arg6); + result = Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::SWIGTEMPLATEDISAMBIGUATOR readSparseFile((std::string const &)*arg1,(Teuchos::RCP< Tpetra::Map< int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const > const &)*arg2,*arg3,(Teuchos::RCP< Tpetra::Map< int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const > const &)*arg4,(Teuchos::RCP< Tpetra::Map< int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const > const &)*arg5); } catch (const std::range_error& e) { // Store a C++ exception - SWIG_exception_impl("Tpetra::MatrixMarket::Reader< CMT >::Tpetra_MatrixMarket_Reader_Sl_CMT_Sg__readSparseGraphFile__SWIG_7(std::string const &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > const &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > const &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > const &,bool const)", SWIG_IndexError, e.what(), return SwigClassWrapper_uninitialized()); + SWIG_exception_impl("Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::readSparseFile(std::string const &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > >::map_type const > const &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > >::map_type const > const &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > >::map_type const > const &)", SWIG_IndexError, e.what(), return SwigClassWrapper_uninitialized()); } catch (const std::exception& e) { // Store a C++ exception - SWIG_exception_impl("Tpetra::MatrixMarket::Reader< CMT >::Tpetra_MatrixMarket_Reader_Sl_CMT_Sg__readSparseGraphFile__SWIG_7(std::string const &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > const &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > const &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > const &,bool const)", SWIG_RuntimeError, e.what(), return SwigClassWrapper_uninitialized()); + SWIG_exception_impl("Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::readSparseFile(std::string const &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > >::map_type const > const &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > >::map_type const > const &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > >::map_type const > const &)", SWIG_RuntimeError, e.what(), return SwigClassWrapper_uninitialized()); } catch (...) { - SWIG_exception_impl("Tpetra::MatrixMarket::Reader< CMT >::Tpetra_MatrixMarket_Reader_Sl_CMT_Sg__readSparseGraphFile__SWIG_7(std::string const &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > const &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > const &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > const &,bool const)", SWIG_UnknownError, "An unknown exception occurred", return SwigClassWrapper_uninitialized()); + SWIG_exception_impl("Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::readSparseFile(std::string const &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > >::map_type const > const &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > >::map_type const > const &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > >::map_type const > const &)", SWIG_UnknownError, "An unknown exception occurred", return SwigClassWrapper_uninitialized()); } } - fresult.cptr = (new Teuchos::RCP< Tpetra::CrsGraph >(static_cast< const Teuchos::RCP< Tpetra::CrsGraph >& >(result))); + fresult.cptr = (new Teuchos::RCP< Tpetra::CrsMatrix >(static_cast< const Teuchos::RCP< Tpetra::CrsMatrix >& >(result))); fresult.mem = SWIG_MOVE; return fresult; } -SWIGEXPORT SwigClassWrapper _wrap_TpetraReader_readSparseGraphFile__SWIG_10(SwigArrayWrapper *farg1, SwigClassWrapper const *farg2, SwigClassWrapper const *farg3, SwigClassWrapper const *farg4, SwigClassWrapper const *farg5) { +SWIGEXPORT SwigClassWrapper _wrap_TpetraReader_readDenseFile(SwigArrayWrapper *farg1, SwigClassWrapper const *farg2, SwigClassWrapper const *farg3) { SwigClassWrapper fresult ; std::string *arg1 = 0 ; - Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > *arg2 = 0 ; + Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > >::comm_type const > *arg2 = 0 ; Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > *arg3 = 0 ; - Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > *arg4 = 0 ; - Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > *arg5 = 0 ; std::string tempstr1 ; - Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > tempnull2 ; + Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > >::comm_type const > tempnull2 ; Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > tempnull3 ; - Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > tempnull4 ; - Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > tempnull5 ; - Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::sparse_graph_type > result; + Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > >::multivector_type > result; tempstr1 = std::string(static_cast(farg1->data), farg1->size); arg1 = &tempstr1; - arg2 = farg2->cptr ? static_cast< Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > * >(farg2->cptr) : &tempnull2; + arg2 = farg2->cptr ? static_cast< Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > >::comm_type const > * >(farg2->cptr) : &tempnull2; arg3 = farg3->cptr ? static_cast< Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > * >(farg3->cptr) : &tempnull3; - arg4 = farg4->cptr ? static_cast< Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > * >(farg4->cptr) : &tempnull4; - arg5 = farg5->cptr ? static_cast< Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > * >(farg5->cptr) : &tempnull5; { // Make sure no unhandled exceptions exist before performing a new action - SWIG_check_unhandled_exception_impl("Tpetra::MatrixMarket::Reader< CMT >::Tpetra_MatrixMarket_Reader_Sl_CMT_Sg__readSparseGraphFile__SWIG_7(std::string const &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > const &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > const &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > const &)");; + SWIG_check_unhandled_exception_impl("Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::readDenseFile(std::string const &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > >::comm_type const > const &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > &)");; try { // Attempt the wrapped function call - result = Tpetra_MatrixMarket_Reader_Sl_CMT_Sg__readSparseGraphFile__SWIG_7((std::string const &)*arg1,(Teuchos::RCP< Tpetra::Map< int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const > const &)*arg2,*arg3,(Teuchos::RCP< Tpetra::Map< int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const > const &)*arg4,(Teuchos::RCP< Tpetra::Map< int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const > const &)*arg5); + result = Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::SWIGTEMPLATEDISAMBIGUATOR readDenseFile((std::string const &)*arg1,(Teuchos::RCP< Teuchos::Comm< int > const > const &)*arg2,*arg3); } catch (const std::range_error& e) { // Store a C++ exception - SWIG_exception_impl("Tpetra::MatrixMarket::Reader< CMT >::Tpetra_MatrixMarket_Reader_Sl_CMT_Sg__readSparseGraphFile__SWIG_7(std::string const &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > const &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > const &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > const &)", SWIG_IndexError, e.what(), return SwigClassWrapper_uninitialized()); + SWIG_exception_impl("Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::readDenseFile(std::string const &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > >::comm_type const > const &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > &)", SWIG_IndexError, e.what(), return SwigClassWrapper_uninitialized()); } catch (const std::exception& e) { // Store a C++ exception - SWIG_exception_impl("Tpetra::MatrixMarket::Reader< CMT >::Tpetra_MatrixMarket_Reader_Sl_CMT_Sg__readSparseGraphFile__SWIG_7(std::string const &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > const &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > const &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > const &)", SWIG_RuntimeError, e.what(), return SwigClassWrapper_uninitialized()); + SWIG_exception_impl("Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::readDenseFile(std::string const &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > >::comm_type const > const &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > &)", SWIG_RuntimeError, e.what(), return SwigClassWrapper_uninitialized()); } catch (...) { - SWIG_exception_impl("Tpetra::MatrixMarket::Reader< CMT >::Tpetra_MatrixMarket_Reader_Sl_CMT_Sg__readSparseGraphFile__SWIG_7(std::string const &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > const &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > const &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > const &)", SWIG_UnknownError, "An unknown exception occurred", return SwigClassWrapper_uninitialized()); + SWIG_exception_impl("Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::readDenseFile(std::string const &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > >::comm_type const > const &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > &)", SWIG_UnknownError, "An unknown exception occurred", return SwigClassWrapper_uninitialized()); } } - fresult.cptr = (new Teuchos::RCP< Tpetra::CrsGraph >(static_cast< const Teuchos::RCP< Tpetra::CrsGraph >& >(result))); + fresult.cptr = (new Teuchos::RCP< Tpetra::MultiVector >(static_cast< const Teuchos::RCP< Tpetra::MultiVector >& >(result))); fresult.mem = SWIG_MOVE; return fresult; } -SWIGEXPORT SwigClassWrapper _wrap_TpetraReader_readSparseFile__SWIG_0(SwigArrayWrapper *farg1, SwigClassWrapper const *farg2, int const *farg3, int const *farg4, int const *farg5) { +SWIGEXPORT SwigClassWrapper _wrap_TpetraReader_readMapFile(SwigArrayWrapper *farg1, SwigClassWrapper const *farg2) { SwigClassWrapper fresult ; std::string *arg1 = 0 ; - Teuchos::RCP< Teuchos::Comm< int > const > *arg2 = 0 ; - bool arg3 ; - bool arg4 ; - bool arg5 ; + Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > >::comm_type const > *arg2 = 0 ; std::string tempstr1 ; - Teuchos::RCP< Teuchos::Comm< int > const > tempnull2 ; - Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::sparse_matrix_type > result; + Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > >::comm_type const > tempnull2 ; + Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > result; tempstr1 = std::string(static_cast(farg1->data), farg1->size); arg1 = &tempstr1; - arg2 = farg2->cptr ? static_cast< Teuchos::RCP< Teuchos::Comm< int > const > * >(farg2->cptr) : &tempnull2; - arg3 = (*farg3 ? true : false); - arg4 = (*farg4 ? true : false); - arg5 = (*farg5 ? true : false); + arg2 = farg2->cptr ? static_cast< Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > >::comm_type const > * >(farg2->cptr) : &tempnull2; { // Make sure no unhandled exceptions exist before performing a new action - SWIG_check_unhandled_exception_impl("Tpetra::MatrixMarket::Reader< CMT >::Tpetra_MatrixMarket_Reader_Sl_CMT_Sg__readSparseFile__SWIG_0(std::string const &,Teuchos::RCP< Teuchos::Comm< int > const > const &,bool const,bool const,bool const)");; + SWIG_check_unhandled_exception_impl("Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::readMapFile(std::string const &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > >::comm_type const > const &)");; try { // Attempt the wrapped function call - result = Tpetra_MatrixMarket_Reader_Sl_CMT_Sg__readSparseFile__SWIG_0((std::string const &)*arg1,(Teuchos::RCP< Teuchos::Comm< int > const > const &)*arg2,arg3,arg4,arg5); + result = Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::SWIGTEMPLATEDISAMBIGUATOR readMapFile((std::string const &)*arg1,(Teuchos::RCP< Teuchos::Comm< int > const > const &)*arg2); } catch (const std::range_error& e) { // Store a C++ exception - SWIG_exception_impl("Tpetra::MatrixMarket::Reader< CMT >::Tpetra_MatrixMarket_Reader_Sl_CMT_Sg__readSparseFile__SWIG_0(std::string const &,Teuchos::RCP< Teuchos::Comm< int > const > const &,bool const,bool const,bool const)", SWIG_IndexError, e.what(), return SwigClassWrapper_uninitialized()); + SWIG_exception_impl("Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::readMapFile(std::string const &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > >::comm_type const > const &)", SWIG_IndexError, e.what(), return SwigClassWrapper_uninitialized()); } catch (const std::exception& e) { // Store a C++ exception - SWIG_exception_impl("Tpetra::MatrixMarket::Reader< CMT >::Tpetra_MatrixMarket_Reader_Sl_CMT_Sg__readSparseFile__SWIG_0(std::string const &,Teuchos::RCP< Teuchos::Comm< int > const > const &,bool const,bool const,bool const)", SWIG_RuntimeError, e.what(), return SwigClassWrapper_uninitialized()); + SWIG_exception_impl("Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::readMapFile(std::string const &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > >::comm_type const > const &)", SWIG_RuntimeError, e.what(), return SwigClassWrapper_uninitialized()); } catch (...) { - SWIG_exception_impl("Tpetra::MatrixMarket::Reader< CMT >::Tpetra_MatrixMarket_Reader_Sl_CMT_Sg__readSparseFile__SWIG_0(std::string const &,Teuchos::RCP< Teuchos::Comm< int > const > const &,bool const,bool const,bool const)", SWIG_UnknownError, "An unknown exception occurred", return SwigClassWrapper_uninitialized()); + SWIG_exception_impl("Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::readMapFile(std::string const &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > >::comm_type const > const &)", SWIG_UnknownError, "An unknown exception occurred", return SwigClassWrapper_uninitialized()); } } - fresult.cptr = (new Teuchos::RCP< Tpetra::CrsMatrix >(static_cast< const Teuchos::RCP< Tpetra::CrsMatrix >& >(result))); + fresult.cptr = (new Teuchos::RCP >(static_cast< const Teuchos::RCP >& >(result))); fresult.mem = SWIG_MOVE; return fresult; } -SWIGEXPORT SwigClassWrapper _wrap_TpetraReader_readSparseFile__SWIG_1(SwigArrayWrapper *farg1, SwigClassWrapper const *farg2, int const *farg3, int const *farg4) { - SwigClassWrapper fresult ; - std::string *arg1 = 0 ; - Teuchos::RCP< Teuchos::Comm< int > const > *arg2 = 0 ; - bool arg3 ; - bool arg4 ; - std::string tempstr1 ; - Teuchos::RCP< Teuchos::Comm< int > const > tempnull2 ; - Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::sparse_matrix_type > result; +SWIGEXPORT void _wrap_delete_TpetraReader(SwigClassWrapper const *farg1) { + Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > > *arg1 = (Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > > *) 0 ; + Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > > > *smartarg1 ; - tempstr1 = std::string(static_cast(farg1->data), farg1->size); - arg1 = &tempstr1; - arg2 = farg2->cptr ? static_cast< Teuchos::RCP< Teuchos::Comm< int > const > * >(farg2->cptr) : &tempnull2; - arg3 = (*farg3 ? true : false); - arg4 = (*farg4 ? true : false); + smartarg1 = static_cast< Teuchos::RCP< Tpetra::MatrixMarket::Reader > >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::MatrixMarket::Reader >* >(smartarg1->get()) : NULL; { // Make sure no unhandled exceptions exist before performing a new action - SWIG_check_unhandled_exception_impl("Tpetra::MatrixMarket::Reader< CMT >::Tpetra_MatrixMarket_Reader_Sl_CMT_Sg__readSparseFile__SWIG_0(std::string const &,Teuchos::RCP< Teuchos::Comm< int > const > const &,bool const,bool const)");; + SWIG_check_unhandled_exception_impl("Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::~Reader()");; try { // Attempt the wrapped function call - result = Tpetra_MatrixMarket_Reader_Sl_CMT_Sg__readSparseFile__SWIG_0((std::string const &)*arg1,(Teuchos::RCP< Teuchos::Comm< int > const > const &)*arg2,arg3,arg4); + (void)arg1; delete smartarg1; } catch (const std::range_error& e) { // Store a C++ exception - SWIG_exception_impl("Tpetra::MatrixMarket::Reader< CMT >::Tpetra_MatrixMarket_Reader_Sl_CMT_Sg__readSparseFile__SWIG_0(std::string const &,Teuchos::RCP< Teuchos::Comm< int > const > const &,bool const,bool const)", SWIG_IndexError, e.what(), return SwigClassWrapper_uninitialized()); + SWIG_exception_impl("Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::~Reader()", SWIG_IndexError, e.what(), return ); } catch (const std::exception& e) { // Store a C++ exception - SWIG_exception_impl("Tpetra::MatrixMarket::Reader< CMT >::Tpetra_MatrixMarket_Reader_Sl_CMT_Sg__readSparseFile__SWIG_0(std::string const &,Teuchos::RCP< Teuchos::Comm< int > const > const &,bool const,bool const)", SWIG_RuntimeError, e.what(), return SwigClassWrapper_uninitialized()); + SWIG_exception_impl("Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::~Reader()", SWIG_RuntimeError, e.what(), return ); } catch (...) { - SWIG_exception_impl("Tpetra::MatrixMarket::Reader< CMT >::Tpetra_MatrixMarket_Reader_Sl_CMT_Sg__readSparseFile__SWIG_0(std::string const &,Teuchos::RCP< Teuchos::Comm< int > const > const &,bool const,bool const)", SWIG_UnknownError, "An unknown exception occurred", return SwigClassWrapper_uninitialized()); + SWIG_exception_impl("Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::~Reader()", SWIG_UnknownError, "An unknown exception occurred", return ); } } - fresult.cptr = (new Teuchos::RCP< Tpetra::CrsMatrix >(static_cast< const Teuchos::RCP< Tpetra::CrsMatrix >& >(result))); - fresult.mem = SWIG_MOVE; - return fresult; + } -SWIGEXPORT SwigClassWrapper _wrap_TpetraReader_readSparseFile__SWIG_2(SwigArrayWrapper *farg1, SwigClassWrapper const *farg2, int const *farg3) { - SwigClassWrapper fresult ; +SWIGEXPORT void _wrap_assign_TpetraReader(SwigClassWrapper * self, SwigClassWrapper const * other) { + typedef Teuchos::RCP< Tpetra::MatrixMarket::Reader > > swig_lhs_classtype; + SWIG_assign(swig_lhs_classtype, self, + swig_lhs_classtype, const_cast(other), + 0 | swig::IS_DESTR | swig::IS_COPY_CONSTR); +} + + +SWIGEXPORT void _wrap_TpetraWriter_writeSparseFile__SWIG_0(SwigArrayWrapper *farg1, SwigClassWrapper const *farg2, SwigArrayWrapper *farg3, SwigArrayWrapper *farg4) { std::string *arg1 = 0 ; - Teuchos::RCP< Teuchos::Comm< int > const > *arg2 = 0 ; - bool arg3 ; + Teuchos::RCP< Tpetra::MatrixMarket::Writer< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > >::sparse_matrix_type const > *arg2 = 0 ; + std::string *arg3 = 0 ; + std::string *arg4 = 0 ; std::string tempstr1 ; - Teuchos::RCP< Teuchos::Comm< int > const > tempnull2 ; - Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::sparse_matrix_type > result; + Teuchos::RCP< Tpetra::MatrixMarket::Writer< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > >::sparse_matrix_type const > tempnull2 ; + std::string tempstr3 ; + std::string tempstr4 ; tempstr1 = std::string(static_cast(farg1->data), farg1->size); arg1 = &tempstr1; - arg2 = farg2->cptr ? static_cast< Teuchos::RCP< Teuchos::Comm< int > const > * >(farg2->cptr) : &tempnull2; - arg3 = (*farg3 ? true : false); + arg2 = farg2->cptr ? static_cast< Teuchos::RCP< Tpetra::MatrixMarket::Writer< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > >::sparse_matrix_type const > * >(farg2->cptr) : &tempnull2; + tempstr3 = std::string(static_cast(farg3->data), farg3->size); + arg3 = &tempstr3; + tempstr4 = std::string(static_cast(farg4->data), farg4->size); + arg4 = &tempstr4; { // Make sure no unhandled exceptions exist before performing a new action - SWIG_check_unhandled_exception_impl("Tpetra::MatrixMarket::Reader< CMT >::Tpetra_MatrixMarket_Reader_Sl_CMT_Sg__readSparseFile__SWIG_0(std::string const &,Teuchos::RCP< Teuchos::Comm< int > const > const &,bool const)");; + SWIG_check_unhandled_exception_impl("Tpetra::MatrixMarket::Writer< Tpetra::CrsMatrix< SC,LO,GO,NO > >::writeSparseFile(std::string const &,Teuchos::RCP< Tpetra::MatrixMarket::Writer< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > >::sparse_matrix_type const > const &,std::string const &,std::string const &)");; try { // Attempt the wrapped function call - result = Tpetra_MatrixMarket_Reader_Sl_CMT_Sg__readSparseFile__SWIG_0((std::string const &)*arg1,(Teuchos::RCP< Teuchos::Comm< int > const > const &)*arg2,arg3); + Tpetra::MatrixMarket::Writer< Tpetra::CrsMatrix< SC,LO,GO,NO > >::SWIGTEMPLATEDISAMBIGUATOR writeSparseFile((std::string const &)*arg1,(Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const > const &)*arg2,(std::string const &)*arg3,(std::string const &)*arg4); } catch (const std::range_error& e) { // Store a C++ exception - SWIG_exception_impl("Tpetra::MatrixMarket::Reader< CMT >::Tpetra_MatrixMarket_Reader_Sl_CMT_Sg__readSparseFile__SWIG_0(std::string const &,Teuchos::RCP< Teuchos::Comm< int > const > const &,bool const)", SWIG_IndexError, e.what(), return SwigClassWrapper_uninitialized()); + SWIG_exception_impl("Tpetra::MatrixMarket::Writer< Tpetra::CrsMatrix< SC,LO,GO,NO > >::writeSparseFile(std::string const &,Teuchos::RCP< Tpetra::MatrixMarket::Writer< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > >::sparse_matrix_type const > const &,std::string const &,std::string const &)", SWIG_IndexError, e.what(), return ); } catch (const std::exception& e) { // Store a C++ exception - SWIG_exception_impl("Tpetra::MatrixMarket::Reader< CMT >::Tpetra_MatrixMarket_Reader_Sl_CMT_Sg__readSparseFile__SWIG_0(std::string const &,Teuchos::RCP< Teuchos::Comm< int > const > const &,bool const)", SWIG_RuntimeError, e.what(), return SwigClassWrapper_uninitialized()); + SWIG_exception_impl("Tpetra::MatrixMarket::Writer< Tpetra::CrsMatrix< SC,LO,GO,NO > >::writeSparseFile(std::string const &,Teuchos::RCP< Tpetra::MatrixMarket::Writer< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > >::sparse_matrix_type const > const &,std::string const &,std::string const &)", SWIG_RuntimeError, e.what(), return ); } catch (...) { - SWIG_exception_impl("Tpetra::MatrixMarket::Reader< CMT >::Tpetra_MatrixMarket_Reader_Sl_CMT_Sg__readSparseFile__SWIG_0(std::string const &,Teuchos::RCP< Teuchos::Comm< int > const > const &,bool const)", SWIG_UnknownError, "An unknown exception occurred", return SwigClassWrapper_uninitialized()); + SWIG_exception_impl("Tpetra::MatrixMarket::Writer< Tpetra::CrsMatrix< SC,LO,GO,NO > >::writeSparseFile(std::string const &,Teuchos::RCP< Tpetra::MatrixMarket::Writer< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > >::sparse_matrix_type const > const &,std::string const &,std::string const &)", SWIG_UnknownError, "An unknown exception occurred", return ); } } - fresult.cptr = (new Teuchos::RCP< Tpetra::CrsMatrix >(static_cast< const Teuchos::RCP< Tpetra::CrsMatrix >& >(result))); - fresult.mem = SWIG_MOVE; - return fresult; + } -SWIGEXPORT SwigClassWrapper _wrap_TpetraReader_readSparseFile__SWIG_3(SwigArrayWrapper *farg1, SwigClassWrapper const *farg2) { - SwigClassWrapper fresult ; +SWIGEXPORT void _wrap_TpetraWriter_writeSparseFile__SWIG_1(SwigArrayWrapper *farg1, SwigClassWrapper const *farg2) { std::string *arg1 = 0 ; - Teuchos::RCP< Teuchos::Comm< int > const > *arg2 = 0 ; + Teuchos::RCP< Tpetra::MatrixMarket::Writer< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > >::sparse_matrix_type const > *arg2 = 0 ; std::string tempstr1 ; - Teuchos::RCP< Teuchos::Comm< int > const > tempnull2 ; - Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::sparse_matrix_type > result; + Teuchos::RCP< Tpetra::MatrixMarket::Writer< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > >::sparse_matrix_type const > tempnull2 ; tempstr1 = std::string(static_cast(farg1->data), farg1->size); arg1 = &tempstr1; - arg2 = farg2->cptr ? static_cast< Teuchos::RCP< Teuchos::Comm< int > const > * >(farg2->cptr) : &tempnull2; + arg2 = farg2->cptr ? static_cast< Teuchos::RCP< Tpetra::MatrixMarket::Writer< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > >::sparse_matrix_type const > * >(farg2->cptr) : &tempnull2; { // Make sure no unhandled exceptions exist before performing a new action - SWIG_check_unhandled_exception_impl("Tpetra::MatrixMarket::Reader< CMT >::Tpetra_MatrixMarket_Reader_Sl_CMT_Sg__readSparseFile__SWIG_0(std::string const &,Teuchos::RCP< Teuchos::Comm< int > const > const &)");; + SWIG_check_unhandled_exception_impl("Tpetra::MatrixMarket::Writer< Tpetra::CrsMatrix< SC,LO,GO,NO > >::writeSparseFile(std::string const &,Teuchos::RCP< Tpetra::MatrixMarket::Writer< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > >::sparse_matrix_type const > const &)");; try { // Attempt the wrapped function call - result = Tpetra_MatrixMarket_Reader_Sl_CMT_Sg__readSparseFile__SWIG_0((std::string const &)*arg1,(Teuchos::RCP< Teuchos::Comm< int > const > const &)*arg2); + Tpetra::MatrixMarket::Writer< Tpetra::CrsMatrix< SC,LO,GO,NO > >::SWIGTEMPLATEDISAMBIGUATOR writeSparseFile((std::string const &)*arg1,(Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const > const &)*arg2); } catch (const std::range_error& e) { // Store a C++ exception - SWIG_exception_impl("Tpetra::MatrixMarket::Reader< CMT >::Tpetra_MatrixMarket_Reader_Sl_CMT_Sg__readSparseFile__SWIG_0(std::string const &,Teuchos::RCP< Teuchos::Comm< int > const > const &)", SWIG_IndexError, e.what(), return SwigClassWrapper_uninitialized()); + SWIG_exception_impl("Tpetra::MatrixMarket::Writer< Tpetra::CrsMatrix< SC,LO,GO,NO > >::writeSparseFile(std::string const &,Teuchos::RCP< Tpetra::MatrixMarket::Writer< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > >::sparse_matrix_type const > const &)", SWIG_IndexError, e.what(), return ); } catch (const std::exception& e) { // Store a C++ exception - SWIG_exception_impl("Tpetra::MatrixMarket::Reader< CMT >::Tpetra_MatrixMarket_Reader_Sl_CMT_Sg__readSparseFile__SWIG_0(std::string const &,Teuchos::RCP< Teuchos::Comm< int > const > const &)", SWIG_RuntimeError, e.what(), return SwigClassWrapper_uninitialized()); + SWIG_exception_impl("Tpetra::MatrixMarket::Writer< Tpetra::CrsMatrix< SC,LO,GO,NO > >::writeSparseFile(std::string const &,Teuchos::RCP< Tpetra::MatrixMarket::Writer< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > >::sparse_matrix_type const > const &)", SWIG_RuntimeError, e.what(), return ); } catch (...) { - SWIG_exception_impl("Tpetra::MatrixMarket::Reader< CMT >::Tpetra_MatrixMarket_Reader_Sl_CMT_Sg__readSparseFile__SWIG_0(std::string const &,Teuchos::RCP< Teuchos::Comm< int > const > const &)", SWIG_UnknownError, "An unknown exception occurred", return SwigClassWrapper_uninitialized()); + SWIG_exception_impl("Tpetra::MatrixMarket::Writer< Tpetra::CrsMatrix< SC,LO,GO,NO > >::writeSparseFile(std::string const &,Teuchos::RCP< Tpetra::MatrixMarket::Writer< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > >::sparse_matrix_type const > const &)", SWIG_UnknownError, "An unknown exception occurred", return ); } } - fresult.cptr = (new Teuchos::RCP< Tpetra::CrsMatrix >(static_cast< const Teuchos::RCP< Tpetra::CrsMatrix >& >(result))); - fresult.mem = SWIG_MOVE; - return fresult; + } -SWIGEXPORT SwigClassWrapper _wrap_TpetraReader_readSparseFile__SWIG_4(SwigArrayWrapper *farg1, SwigClassWrapper const *farg2, SwigClassWrapper const *farg3, SwigClassWrapper const *farg4, int const *farg5, int const *farg6) { - SwigClassWrapper fresult ; +SWIGEXPORT void _wrap_TpetraWriter_writeSparseGraphFile__SWIG_0(SwigArrayWrapper *farg1, SwigClassWrapper const *farg2, SwigArrayWrapper *farg3, SwigArrayWrapper *farg4) { std::string *arg1 = 0 ; - Teuchos::RCP< Teuchos::Comm< int > const > *arg2 = 0 ; - Teuchos::RCP< Teuchos::ParameterList > *arg3 = 0 ; - Teuchos::RCP< Teuchos::ParameterList > *arg4 = 0 ; - bool arg5 ; - bool arg6 ; + Teuchos::RCP< Tpetra::MatrixMarket::Writer< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > >::crs_graph_type const > *arg2 = 0 ; + std::string *arg3 = 0 ; + std::string *arg4 = 0 ; std::string tempstr1 ; - Teuchos::RCP< Teuchos::Comm< int > const > tempnull2 ; - Teuchos::RCP< Teuchos::ParameterList > tempnull3 ; - Teuchos::RCP< Teuchos::ParameterList > tempnull4 ; - Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::sparse_matrix_type > result; + Teuchos::RCP< Tpetra::MatrixMarket::Writer< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > >::crs_graph_type const > tempnull2 ; + std::string tempstr3 ; + std::string tempstr4 ; tempstr1 = std::string(static_cast(farg1->data), farg1->size); arg1 = &tempstr1; - arg2 = farg2->cptr ? static_cast< Teuchos::RCP< Teuchos::Comm< int > const > * >(farg2->cptr) : &tempnull2; - arg3 = farg3->cptr ? static_cast< Teuchos::RCP< Teuchos::ParameterList > * >(farg3->cptr) : &tempnull3; - arg4 = farg4->cptr ? static_cast< Teuchos::RCP< Teuchos::ParameterList > * >(farg4->cptr) : &tempnull4; - arg5 = (*farg5 ? true : false); - arg6 = (*farg6 ? true : false); + arg2 = farg2->cptr ? static_cast< Teuchos::RCP< Tpetra::MatrixMarket::Writer< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > >::crs_graph_type const > * >(farg2->cptr) : &tempnull2; + tempstr3 = std::string(static_cast(farg3->data), farg3->size); + arg3 = &tempstr3; + tempstr4 = std::string(static_cast(farg4->data), farg4->size); + arg4 = &tempstr4; { // Make sure no unhandled exceptions exist before performing a new action - SWIG_check_unhandled_exception_impl("Tpetra::MatrixMarket::Reader< CMT >::Tpetra_MatrixMarket_Reader_Sl_CMT_Sg__readSparseFile__SWIG_4(std::string const &,Teuchos::RCP< Teuchos::Comm< int > const > const &,Teuchos::RCP< Teuchos::ParameterList > const &,Teuchos::RCP< Teuchos::ParameterList > const &,bool const,bool const)");; + SWIG_check_unhandled_exception_impl("Tpetra::MatrixMarket::Writer< Tpetra::CrsMatrix< SC,LO,GO,NO > >::writeSparseGraphFile(std::string const &,Teuchos::RCP< Tpetra::MatrixMarket::Writer< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > >::crs_graph_type const > const &,std::string const &,std::string const &)");; try { // Attempt the wrapped function call - result = Tpetra_MatrixMarket_Reader_Sl_CMT_Sg__readSparseFile__SWIG_4((std::string const &)*arg1,(Teuchos::RCP< Teuchos::Comm< int > const > const &)*arg2,(Teuchos::RCP< Teuchos::ParameterList > const &)*arg3,(Teuchos::RCP< Teuchos::ParameterList > const &)*arg4,arg5,arg6); + Tpetra::MatrixMarket::Writer< Tpetra::CrsMatrix< SC,LO,GO,NO > >::SWIGTEMPLATEDISAMBIGUATOR writeSparseGraphFile((std::string const &)*arg1,(Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const > const &)*arg2,(std::string const &)*arg3,(std::string const &)*arg4); } catch (const std::range_error& e) { // Store a C++ exception - SWIG_exception_impl("Tpetra::MatrixMarket::Reader< CMT >::Tpetra_MatrixMarket_Reader_Sl_CMT_Sg__readSparseFile__SWIG_4(std::string const &,Teuchos::RCP< Teuchos::Comm< int > const > const &,Teuchos::RCP< Teuchos::ParameterList > const &,Teuchos::RCP< Teuchos::ParameterList > const &,bool const,bool const)", SWIG_IndexError, e.what(), return SwigClassWrapper_uninitialized()); + SWIG_exception_impl("Tpetra::MatrixMarket::Writer< Tpetra::CrsMatrix< SC,LO,GO,NO > >::writeSparseGraphFile(std::string const &,Teuchos::RCP< Tpetra::MatrixMarket::Writer< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > >::crs_graph_type const > const &,std::string const &,std::string const &)", SWIG_IndexError, e.what(), return ); } catch (const std::exception& e) { // Store a C++ exception - SWIG_exception_impl("Tpetra::MatrixMarket::Reader< CMT >::Tpetra_MatrixMarket_Reader_Sl_CMT_Sg__readSparseFile__SWIG_4(std::string const &,Teuchos::RCP< Teuchos::Comm< int > const > const &,Teuchos::RCP< Teuchos::ParameterList > const &,Teuchos::RCP< Teuchos::ParameterList > const &,bool const,bool const)", SWIG_RuntimeError, e.what(), return SwigClassWrapper_uninitialized()); + SWIG_exception_impl("Tpetra::MatrixMarket::Writer< Tpetra::CrsMatrix< SC,LO,GO,NO > >::writeSparseGraphFile(std::string const &,Teuchos::RCP< Tpetra::MatrixMarket::Writer< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > >::crs_graph_type const > const &,std::string const &,std::string const &)", SWIG_RuntimeError, e.what(), return ); } catch (...) { - SWIG_exception_impl("Tpetra::MatrixMarket::Reader< CMT >::Tpetra_MatrixMarket_Reader_Sl_CMT_Sg__readSparseFile__SWIG_4(std::string const &,Teuchos::RCP< Teuchos::Comm< int > const > const &,Teuchos::RCP< Teuchos::ParameterList > const &,Teuchos::RCP< Teuchos::ParameterList > const &,bool const,bool const)", SWIG_UnknownError, "An unknown exception occurred", return SwigClassWrapper_uninitialized()); + SWIG_exception_impl("Tpetra::MatrixMarket::Writer< Tpetra::CrsMatrix< SC,LO,GO,NO > >::writeSparseGraphFile(std::string const &,Teuchos::RCP< Tpetra::MatrixMarket::Writer< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > >::crs_graph_type const > const &,std::string const &,std::string const &)", SWIG_UnknownError, "An unknown exception occurred", return ); } } - fresult.cptr = (new Teuchos::RCP< Tpetra::CrsMatrix >(static_cast< const Teuchos::RCP< Tpetra::CrsMatrix >& >(result))); - fresult.mem = SWIG_MOVE; - return fresult; + } -SWIGEXPORT SwigClassWrapper _wrap_TpetraReader_readSparseFile__SWIG_5(SwigArrayWrapper *farg1, SwigClassWrapper const *farg2, SwigClassWrapper const *farg3, SwigClassWrapper const *farg4, int const *farg5) { - SwigClassWrapper fresult ; +SWIGEXPORT void _wrap_TpetraWriter_writeSparseGraphFile__SWIG_1(SwigArrayWrapper *farg1, SwigClassWrapper const *farg2) { std::string *arg1 = 0 ; - Teuchos::RCP< Teuchos::Comm< int > const > *arg2 = 0 ; - Teuchos::RCP< Teuchos::ParameterList > *arg3 = 0 ; - Teuchos::RCP< Teuchos::ParameterList > *arg4 = 0 ; - bool arg5 ; + Teuchos::RCP< Tpetra::MatrixMarket::Writer< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > >::crs_graph_type const > *arg2 = 0 ; std::string tempstr1 ; - Teuchos::RCP< Teuchos::Comm< int > const > tempnull2 ; - Teuchos::RCP< Teuchos::ParameterList > tempnull3 ; - Teuchos::RCP< Teuchos::ParameterList > tempnull4 ; - Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::sparse_matrix_type > result; + Teuchos::RCP< Tpetra::MatrixMarket::Writer< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > >::crs_graph_type const > tempnull2 ; tempstr1 = std::string(static_cast(farg1->data), farg1->size); arg1 = &tempstr1; - arg2 = farg2->cptr ? static_cast< Teuchos::RCP< Teuchos::Comm< int > const > * >(farg2->cptr) : &tempnull2; - arg3 = farg3->cptr ? static_cast< Teuchos::RCP< Teuchos::ParameterList > * >(farg3->cptr) : &tempnull3; - arg4 = farg4->cptr ? static_cast< Teuchos::RCP< Teuchos::ParameterList > * >(farg4->cptr) : &tempnull4; - arg5 = (*farg5 ? true : false); + arg2 = farg2->cptr ? static_cast< Teuchos::RCP< Tpetra::MatrixMarket::Writer< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > >::crs_graph_type const > * >(farg2->cptr) : &tempnull2; { // Make sure no unhandled exceptions exist before performing a new action - SWIG_check_unhandled_exception_impl("Tpetra::MatrixMarket::Reader< CMT >::Tpetra_MatrixMarket_Reader_Sl_CMT_Sg__readSparseFile__SWIG_4(std::string const &,Teuchos::RCP< Teuchos::Comm< int > const > const &,Teuchos::RCP< Teuchos::ParameterList > const &,Teuchos::RCP< Teuchos::ParameterList > const &,bool const)");; + SWIG_check_unhandled_exception_impl("Tpetra::MatrixMarket::Writer< Tpetra::CrsMatrix< SC,LO,GO,NO > >::writeSparseGraphFile(std::string const &,Teuchos::RCP< Tpetra::MatrixMarket::Writer< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > >::crs_graph_type const > const &)");; try { // Attempt the wrapped function call - result = Tpetra_MatrixMarket_Reader_Sl_CMT_Sg__readSparseFile__SWIG_4((std::string const &)*arg1,(Teuchos::RCP< Teuchos::Comm< int > const > const &)*arg2,(Teuchos::RCP< Teuchos::ParameterList > const &)*arg3,(Teuchos::RCP< Teuchos::ParameterList > const &)*arg4,arg5); + Tpetra::MatrixMarket::Writer< Tpetra::CrsMatrix< SC,LO,GO,NO > >::SWIGTEMPLATEDISAMBIGUATOR writeSparseGraphFile((std::string const &)*arg1,(Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const > const &)*arg2); } catch (const std::range_error& e) { // Store a C++ exception - SWIG_exception_impl("Tpetra::MatrixMarket::Reader< CMT >::Tpetra_MatrixMarket_Reader_Sl_CMT_Sg__readSparseFile__SWIG_4(std::string const &,Teuchos::RCP< Teuchos::Comm< int > const > const &,Teuchos::RCP< Teuchos::ParameterList > const &,Teuchos::RCP< Teuchos::ParameterList > const &,bool const)", SWIG_IndexError, e.what(), return SwigClassWrapper_uninitialized()); + SWIG_exception_impl("Tpetra::MatrixMarket::Writer< Tpetra::CrsMatrix< SC,LO,GO,NO > >::writeSparseGraphFile(std::string const &,Teuchos::RCP< Tpetra::MatrixMarket::Writer< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > >::crs_graph_type const > const &)", SWIG_IndexError, e.what(), return ); } catch (const std::exception& e) { // Store a C++ exception - SWIG_exception_impl("Tpetra::MatrixMarket::Reader< CMT >::Tpetra_MatrixMarket_Reader_Sl_CMT_Sg__readSparseFile__SWIG_4(std::string const &,Teuchos::RCP< Teuchos::Comm< int > const > const &,Teuchos::RCP< Teuchos::ParameterList > const &,Teuchos::RCP< Teuchos::ParameterList > const &,bool const)", SWIG_RuntimeError, e.what(), return SwigClassWrapper_uninitialized()); + SWIG_exception_impl("Tpetra::MatrixMarket::Writer< Tpetra::CrsMatrix< SC,LO,GO,NO > >::writeSparseGraphFile(std::string const &,Teuchos::RCP< Tpetra::MatrixMarket::Writer< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > >::crs_graph_type const > const &)", SWIG_RuntimeError, e.what(), return ); } catch (...) { - SWIG_exception_impl("Tpetra::MatrixMarket::Reader< CMT >::Tpetra_MatrixMarket_Reader_Sl_CMT_Sg__readSparseFile__SWIG_4(std::string const &,Teuchos::RCP< Teuchos::Comm< int > const > const &,Teuchos::RCP< Teuchos::ParameterList > const &,Teuchos::RCP< Teuchos::ParameterList > const &,bool const)", SWIG_UnknownError, "An unknown exception occurred", return SwigClassWrapper_uninitialized()); + SWIG_exception_impl("Tpetra::MatrixMarket::Writer< Tpetra::CrsMatrix< SC,LO,GO,NO > >::writeSparseGraphFile(std::string const &,Teuchos::RCP< Tpetra::MatrixMarket::Writer< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > >::crs_graph_type const > const &)", SWIG_UnknownError, "An unknown exception occurred", return ); } } - fresult.cptr = (new Teuchos::RCP< Tpetra::CrsMatrix >(static_cast< const Teuchos::RCP< Tpetra::CrsMatrix >& >(result))); - fresult.mem = SWIG_MOVE; - return fresult; + } -SWIGEXPORT SwigClassWrapper _wrap_TpetraReader_readSparseFile__SWIG_6(SwigArrayWrapper *farg1, SwigClassWrapper const *farg2, SwigClassWrapper const *farg3, SwigClassWrapper const *farg4) { - SwigClassWrapper fresult ; +SWIGEXPORT void _wrap_TpetraWriter_writeDenseFile__SWIG_0(SwigArrayWrapper *farg1, SwigClassWrapper const *farg2, SwigArrayWrapper *farg3, SwigArrayWrapper *farg4) { std::string *arg1 = 0 ; - Teuchos::RCP< Teuchos::Comm< int > const > *arg2 = 0 ; - Teuchos::RCP< Teuchos::ParameterList > *arg3 = 0 ; - Teuchos::RCP< Teuchos::ParameterList > *arg4 = 0 ; + Teuchos::RCP< Tpetra::MatrixMarket::Writer< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > >::multivector_type const > *arg2 = 0 ; + std::string *arg3 = 0 ; + std::string *arg4 = 0 ; std::string tempstr1 ; - Teuchos::RCP< Teuchos::Comm< int > const > tempnull2 ; - Teuchos::RCP< Teuchos::ParameterList > tempnull3 ; - Teuchos::RCP< Teuchos::ParameterList > tempnull4 ; - Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::sparse_matrix_type > result; + Teuchos::RCP< Tpetra::MatrixMarket::Writer< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > >::multivector_type const > tempnull2 ; + std::string tempstr3 ; + std::string tempstr4 ; tempstr1 = std::string(static_cast(farg1->data), farg1->size); arg1 = &tempstr1; - arg2 = farg2->cptr ? static_cast< Teuchos::RCP< Teuchos::Comm< int > const > * >(farg2->cptr) : &tempnull2; - arg3 = farg3->cptr ? static_cast< Teuchos::RCP< Teuchos::ParameterList > * >(farg3->cptr) : &tempnull3; - arg4 = farg4->cptr ? static_cast< Teuchos::RCP< Teuchos::ParameterList > * >(farg4->cptr) : &tempnull4; + arg2 = farg2->cptr ? static_cast< Teuchos::RCP< Tpetra::MatrixMarket::Writer< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > >::multivector_type const > * >(farg2->cptr) : &tempnull2; + tempstr3 = std::string(static_cast(farg3->data), farg3->size); + arg3 = &tempstr3; + tempstr4 = std::string(static_cast(farg4->data), farg4->size); + arg4 = &tempstr4; { // Make sure no unhandled exceptions exist before performing a new action - SWIG_check_unhandled_exception_impl("Tpetra::MatrixMarket::Reader< CMT >::Tpetra_MatrixMarket_Reader_Sl_CMT_Sg__readSparseFile__SWIG_4(std::string const &,Teuchos::RCP< Teuchos::Comm< int > const > const &,Teuchos::RCP< Teuchos::ParameterList > const &,Teuchos::RCP< Teuchos::ParameterList > const &)");; + SWIG_check_unhandled_exception_impl("Tpetra::MatrixMarket::Writer< Tpetra::CrsMatrix< SC,LO,GO,NO > >::writeDenseFile(std::string const &,Teuchos::RCP< Tpetra::MatrixMarket::Writer< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > >::multivector_type const > const &,std::string const &,std::string const &)");; try { // Attempt the wrapped function call - result = Tpetra_MatrixMarket_Reader_Sl_CMT_Sg__readSparseFile__SWIG_4((std::string const &)*arg1,(Teuchos::RCP< Teuchos::Comm< int > const > const &)*arg2,(Teuchos::RCP< Teuchos::ParameterList > const &)*arg3,(Teuchos::RCP< Teuchos::ParameterList > const &)*arg4); + Tpetra::MatrixMarket::Writer< Tpetra::CrsMatrix< SC,LO,GO,NO > >::SWIGTEMPLATEDISAMBIGUATOR writeDenseFile((std::string const &)*arg1,(Teuchos::RCP< Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const > const &)*arg2,(std::string const &)*arg3,(std::string const &)*arg4); } catch (const std::range_error& e) { // Store a C++ exception - SWIG_exception_impl("Tpetra::MatrixMarket::Reader< CMT >::Tpetra_MatrixMarket_Reader_Sl_CMT_Sg__readSparseFile__SWIG_4(std::string const &,Teuchos::RCP< Teuchos::Comm< int > const > const &,Teuchos::RCP< Teuchos::ParameterList > const &,Teuchos::RCP< Teuchos::ParameterList > const &)", SWIG_IndexError, e.what(), return SwigClassWrapper_uninitialized()); + SWIG_exception_impl("Tpetra::MatrixMarket::Writer< Tpetra::CrsMatrix< SC,LO,GO,NO > >::writeDenseFile(std::string const &,Teuchos::RCP< Tpetra::MatrixMarket::Writer< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > >::multivector_type const > const &,std::string const &,std::string const &)", SWIG_IndexError, e.what(), return ); } catch (const std::exception& e) { // Store a C++ exception - SWIG_exception_impl("Tpetra::MatrixMarket::Reader< CMT >::Tpetra_MatrixMarket_Reader_Sl_CMT_Sg__readSparseFile__SWIG_4(std::string const &,Teuchos::RCP< Teuchos::Comm< int > const > const &,Teuchos::RCP< Teuchos::ParameterList > const &,Teuchos::RCP< Teuchos::ParameterList > const &)", SWIG_RuntimeError, e.what(), return SwigClassWrapper_uninitialized()); + SWIG_exception_impl("Tpetra::MatrixMarket::Writer< Tpetra::CrsMatrix< SC,LO,GO,NO > >::writeDenseFile(std::string const &,Teuchos::RCP< Tpetra::MatrixMarket::Writer< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > >::multivector_type const > const &,std::string const &,std::string const &)", SWIG_RuntimeError, e.what(), return ); } catch (...) { - SWIG_exception_impl("Tpetra::MatrixMarket::Reader< CMT >::Tpetra_MatrixMarket_Reader_Sl_CMT_Sg__readSparseFile__SWIG_4(std::string const &,Teuchos::RCP< Teuchos::Comm< int > const > const &,Teuchos::RCP< Teuchos::ParameterList > const &,Teuchos::RCP< Teuchos::ParameterList > const &)", SWIG_UnknownError, "An unknown exception occurred", return SwigClassWrapper_uninitialized()); - } - } - fresult.cptr = (new Teuchos::RCP< Tpetra::CrsMatrix >(static_cast< const Teuchos::RCP< Tpetra::CrsMatrix >& >(result))); - fresult.mem = SWIG_MOVE; - return fresult; -} - - -SWIGEXPORT SwigClassWrapper _wrap_TpetraReader_readSparseFile__SWIG_7(SwigArrayWrapper *farg1, SwigClassWrapper const *farg2, SwigClassWrapper const *farg3, SwigClassWrapper const *farg4, SwigClassWrapper const *farg5, int const *farg6, int const *farg7, int const *farg8) { - SwigClassWrapper fresult ; - std::string *arg1 = 0 ; - Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > *arg2 = 0 ; - Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > *arg3 = 0 ; - Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > *arg4 = 0 ; - Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > *arg5 = 0 ; - bool arg6 ; - bool arg7 ; - bool arg8 ; - std::string tempstr1 ; - Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > tempnull2 ; - Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > tempnull3 ; - Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > tempnull4 ; - Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > tempnull5 ; - Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::sparse_matrix_type > result; - - tempstr1 = std::string(static_cast(farg1->data), farg1->size); - arg1 = &tempstr1; - arg2 = farg2->cptr ? static_cast< Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > * >(farg2->cptr) : &tempnull2; - arg3 = farg3->cptr ? static_cast< Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > * >(farg3->cptr) : &tempnull3; - arg4 = farg4->cptr ? static_cast< Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > * >(farg4->cptr) : &tempnull4; - arg5 = farg5->cptr ? static_cast< Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > * >(farg5->cptr) : &tempnull5; - arg6 = (*farg6 ? true : false); - arg7 = (*farg7 ? true : false); - arg8 = (*farg8 ? true : false); - { - // Make sure no unhandled exceptions exist before performing a new action - SWIG_check_unhandled_exception_impl("Tpetra::MatrixMarket::Reader< CMT >::Tpetra_MatrixMarket_Reader_Sl_CMT_Sg__readSparseFile__SWIG_7(std::string const &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > const &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > const &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > const &,bool const,bool const,bool const)");; - try - { - // Attempt the wrapped function call - result = Tpetra_MatrixMarket_Reader_Sl_CMT_Sg__readSparseFile__SWIG_7((std::string const &)*arg1,(Teuchos::RCP< Tpetra::Map< int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const > const &)*arg2,*arg3,(Teuchos::RCP< Tpetra::Map< int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const > const &)*arg4,(Teuchos::RCP< Tpetra::Map< int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const > const &)*arg5,arg6,arg7,arg8); - } - catch (const std::range_error& e) - { - // Store a C++ exception - SWIG_exception_impl("Tpetra::MatrixMarket::Reader< CMT >::Tpetra_MatrixMarket_Reader_Sl_CMT_Sg__readSparseFile__SWIG_7(std::string const &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > const &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > const &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > const &,bool const,bool const,bool const)", SWIG_IndexError, e.what(), return SwigClassWrapper_uninitialized()); - } - catch (const std::exception& e) - { - // Store a C++ exception - SWIG_exception_impl("Tpetra::MatrixMarket::Reader< CMT >::Tpetra_MatrixMarket_Reader_Sl_CMT_Sg__readSparseFile__SWIG_7(std::string const &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > const &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > const &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > const &,bool const,bool const,bool const)", SWIG_RuntimeError, e.what(), return SwigClassWrapper_uninitialized()); - } - catch (...) - { - SWIG_exception_impl("Tpetra::MatrixMarket::Reader< CMT >::Tpetra_MatrixMarket_Reader_Sl_CMT_Sg__readSparseFile__SWIG_7(std::string const &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > const &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > const &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > const &,bool const,bool const,bool const)", SWIG_UnknownError, "An unknown exception occurred", return SwigClassWrapper_uninitialized()); - } - } - fresult.cptr = (new Teuchos::RCP< Tpetra::CrsMatrix >(static_cast< const Teuchos::RCP< Tpetra::CrsMatrix >& >(result))); - fresult.mem = SWIG_MOVE; - return fresult; -} - - -SWIGEXPORT SwigClassWrapper _wrap_TpetraReader_readSparseFile__SWIG_8(SwigArrayWrapper *farg1, SwigClassWrapper const *farg2, SwigClassWrapper const *farg3, SwigClassWrapper const *farg4, SwigClassWrapper const *farg5, int const *farg6, int const *farg7) { - SwigClassWrapper fresult ; - std::string *arg1 = 0 ; - Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > *arg2 = 0 ; - Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > *arg3 = 0 ; - Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > *arg4 = 0 ; - Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > *arg5 = 0 ; - bool arg6 ; - bool arg7 ; - std::string tempstr1 ; - Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > tempnull2 ; - Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > tempnull3 ; - Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > tempnull4 ; - Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > tempnull5 ; - Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::sparse_matrix_type > result; - - tempstr1 = std::string(static_cast(farg1->data), farg1->size); - arg1 = &tempstr1; - arg2 = farg2->cptr ? static_cast< Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > * >(farg2->cptr) : &tempnull2; - arg3 = farg3->cptr ? static_cast< Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > * >(farg3->cptr) : &tempnull3; - arg4 = farg4->cptr ? static_cast< Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > * >(farg4->cptr) : &tempnull4; - arg5 = farg5->cptr ? static_cast< Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > * >(farg5->cptr) : &tempnull5; - arg6 = (*farg6 ? true : false); - arg7 = (*farg7 ? true : false); - { - // Make sure no unhandled exceptions exist before performing a new action - SWIG_check_unhandled_exception_impl("Tpetra::MatrixMarket::Reader< CMT >::Tpetra_MatrixMarket_Reader_Sl_CMT_Sg__readSparseFile__SWIG_7(std::string const &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > const &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > const &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > const &,bool const,bool const)");; - try - { - // Attempt the wrapped function call - result = Tpetra_MatrixMarket_Reader_Sl_CMT_Sg__readSparseFile__SWIG_7((std::string const &)*arg1,(Teuchos::RCP< Tpetra::Map< int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const > const &)*arg2,*arg3,(Teuchos::RCP< Tpetra::Map< int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const > const &)*arg4,(Teuchos::RCP< Tpetra::Map< int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const > const &)*arg5,arg6,arg7); - } - catch (const std::range_error& e) - { - // Store a C++ exception - SWIG_exception_impl("Tpetra::MatrixMarket::Reader< CMT >::Tpetra_MatrixMarket_Reader_Sl_CMT_Sg__readSparseFile__SWIG_7(std::string const &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > const &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > const &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > const &,bool const,bool const)", SWIG_IndexError, e.what(), return SwigClassWrapper_uninitialized()); - } - catch (const std::exception& e) - { - // Store a C++ exception - SWIG_exception_impl("Tpetra::MatrixMarket::Reader< CMT >::Tpetra_MatrixMarket_Reader_Sl_CMT_Sg__readSparseFile__SWIG_7(std::string const &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > const &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > const &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > const &,bool const,bool const)", SWIG_RuntimeError, e.what(), return SwigClassWrapper_uninitialized()); - } - catch (...) - { - SWIG_exception_impl("Tpetra::MatrixMarket::Reader< CMT >::Tpetra_MatrixMarket_Reader_Sl_CMT_Sg__readSparseFile__SWIG_7(std::string const &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > const &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > const &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > const &,bool const,bool const)", SWIG_UnknownError, "An unknown exception occurred", return SwigClassWrapper_uninitialized()); - } - } - fresult.cptr = (new Teuchos::RCP< Tpetra::CrsMatrix >(static_cast< const Teuchos::RCP< Tpetra::CrsMatrix >& >(result))); - fresult.mem = SWIG_MOVE; - return fresult; -} - - -SWIGEXPORT SwigClassWrapper _wrap_TpetraReader_readSparseFile__SWIG_9(SwigArrayWrapper *farg1, SwigClassWrapper const *farg2, SwigClassWrapper const *farg3, SwigClassWrapper const *farg4, SwigClassWrapper const *farg5, int const *farg6) { - SwigClassWrapper fresult ; - std::string *arg1 = 0 ; - Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > *arg2 = 0 ; - Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > *arg3 = 0 ; - Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > *arg4 = 0 ; - Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > *arg5 = 0 ; - bool arg6 ; - std::string tempstr1 ; - Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > tempnull2 ; - Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > tempnull3 ; - Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > tempnull4 ; - Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > tempnull5 ; - Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::sparse_matrix_type > result; - - tempstr1 = std::string(static_cast(farg1->data), farg1->size); - arg1 = &tempstr1; - arg2 = farg2->cptr ? static_cast< Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > * >(farg2->cptr) : &tempnull2; - arg3 = farg3->cptr ? static_cast< Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > * >(farg3->cptr) : &tempnull3; - arg4 = farg4->cptr ? static_cast< Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > * >(farg4->cptr) : &tempnull4; - arg5 = farg5->cptr ? static_cast< Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > * >(farg5->cptr) : &tempnull5; - arg6 = (*farg6 ? true : false); - { - // Make sure no unhandled exceptions exist before performing a new action - SWIG_check_unhandled_exception_impl("Tpetra::MatrixMarket::Reader< CMT >::Tpetra_MatrixMarket_Reader_Sl_CMT_Sg__readSparseFile__SWIG_7(std::string const &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > const &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > const &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > const &,bool const)");; - try - { - // Attempt the wrapped function call - result = Tpetra_MatrixMarket_Reader_Sl_CMT_Sg__readSparseFile__SWIG_7((std::string const &)*arg1,(Teuchos::RCP< Tpetra::Map< int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const > const &)*arg2,*arg3,(Teuchos::RCP< Tpetra::Map< int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const > const &)*arg4,(Teuchos::RCP< Tpetra::Map< int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const > const &)*arg5,arg6); - } - catch (const std::range_error& e) - { - // Store a C++ exception - SWIG_exception_impl("Tpetra::MatrixMarket::Reader< CMT >::Tpetra_MatrixMarket_Reader_Sl_CMT_Sg__readSparseFile__SWIG_7(std::string const &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > const &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > const &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > const &,bool const)", SWIG_IndexError, e.what(), return SwigClassWrapper_uninitialized()); - } - catch (const std::exception& e) - { - // Store a C++ exception - SWIG_exception_impl("Tpetra::MatrixMarket::Reader< CMT >::Tpetra_MatrixMarket_Reader_Sl_CMT_Sg__readSparseFile__SWIG_7(std::string const &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > const &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > const &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > const &,bool const)", SWIG_RuntimeError, e.what(), return SwigClassWrapper_uninitialized()); - } - catch (...) - { - SWIG_exception_impl("Tpetra::MatrixMarket::Reader< CMT >::Tpetra_MatrixMarket_Reader_Sl_CMT_Sg__readSparseFile__SWIG_7(std::string const &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > const &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > const &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > const &,bool const)", SWIG_UnknownError, "An unknown exception occurred", return SwigClassWrapper_uninitialized()); - } - } - fresult.cptr = (new Teuchos::RCP< Tpetra::CrsMatrix >(static_cast< const Teuchos::RCP< Tpetra::CrsMatrix >& >(result))); - fresult.mem = SWIG_MOVE; - return fresult; -} - - -SWIGEXPORT SwigClassWrapper _wrap_TpetraReader_readSparseFile__SWIG_10(SwigArrayWrapper *farg1, SwigClassWrapper const *farg2, SwigClassWrapper const *farg3, SwigClassWrapper const *farg4, SwigClassWrapper const *farg5) { - SwigClassWrapper fresult ; - std::string *arg1 = 0 ; - Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > *arg2 = 0 ; - Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > *arg3 = 0 ; - Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > *arg4 = 0 ; - Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > *arg5 = 0 ; - std::string tempstr1 ; - Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > tempnull2 ; - Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > tempnull3 ; - Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > tempnull4 ; - Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > tempnull5 ; - Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::sparse_matrix_type > result; - - tempstr1 = std::string(static_cast(farg1->data), farg1->size); - arg1 = &tempstr1; - arg2 = farg2->cptr ? static_cast< Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > * >(farg2->cptr) : &tempnull2; - arg3 = farg3->cptr ? static_cast< Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > * >(farg3->cptr) : &tempnull3; - arg4 = farg4->cptr ? static_cast< Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > * >(farg4->cptr) : &tempnull4; - arg5 = farg5->cptr ? static_cast< Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > * >(farg5->cptr) : &tempnull5; - { - // Make sure no unhandled exceptions exist before performing a new action - SWIG_check_unhandled_exception_impl("Tpetra::MatrixMarket::Reader< CMT >::Tpetra_MatrixMarket_Reader_Sl_CMT_Sg__readSparseFile__SWIG_7(std::string const &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > const &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > const &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > const &)");; - try - { - // Attempt the wrapped function call - result = Tpetra_MatrixMarket_Reader_Sl_CMT_Sg__readSparseFile__SWIG_7((std::string const &)*arg1,(Teuchos::RCP< Tpetra::Map< int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const > const &)*arg2,*arg3,(Teuchos::RCP< Tpetra::Map< int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const > const &)*arg4,(Teuchos::RCP< Tpetra::Map< int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const > const &)*arg5); - } - catch (const std::range_error& e) - { - // Store a C++ exception - SWIG_exception_impl("Tpetra::MatrixMarket::Reader< CMT >::Tpetra_MatrixMarket_Reader_Sl_CMT_Sg__readSparseFile__SWIG_7(std::string const &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > const &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > const &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > const &)", SWIG_IndexError, e.what(), return SwigClassWrapper_uninitialized()); - } - catch (const std::exception& e) - { - // Store a C++ exception - SWIG_exception_impl("Tpetra::MatrixMarket::Reader< CMT >::Tpetra_MatrixMarket_Reader_Sl_CMT_Sg__readSparseFile__SWIG_7(std::string const &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > const &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > const &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > const &)", SWIG_RuntimeError, e.what(), return SwigClassWrapper_uninitialized()); - } - catch (...) - { - SWIG_exception_impl("Tpetra::MatrixMarket::Reader< CMT >::Tpetra_MatrixMarket_Reader_Sl_CMT_Sg__readSparseFile__SWIG_7(std::string const &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > const &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > const &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > const &)", SWIG_UnknownError, "An unknown exception occurred", return SwigClassWrapper_uninitialized()); - } - } - fresult.cptr = (new Teuchos::RCP< Tpetra::CrsMatrix >(static_cast< const Teuchos::RCP< Tpetra::CrsMatrix >& >(result))); - fresult.mem = SWIG_MOVE; - return fresult; -} - - -SWIGEXPORT SwigClassWrapper _wrap_TpetraReader_readDenseFile__SWIG_0(SwigArrayWrapper *farg1, SwigClassWrapper const *farg2, SwigClassWrapper const *farg3, int const *farg4, int const *farg5) { - SwigClassWrapper fresult ; - std::string *arg1 = 0 ; - Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::comm_type const > *arg2 = 0 ; - Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > *arg3 = 0 ; - bool arg4 ; - bool arg5 ; - std::string tempstr1 ; - Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::comm_type const > tempnull2 ; - Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > tempnull3 ; - Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::multivector_type > result; - - tempstr1 = std::string(static_cast(farg1->data), farg1->size); - arg1 = &tempstr1; - arg2 = farg2->cptr ? static_cast< Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::comm_type const > * >(farg2->cptr) : &tempnull2; - arg3 = farg3->cptr ? static_cast< Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > * >(farg3->cptr) : &tempnull3; - arg4 = (*farg4 ? true : false); - arg5 = (*farg5 ? true : false); - { - // Make sure no unhandled exceptions exist before performing a new action - SWIG_check_unhandled_exception_impl("Tpetra::MatrixMarket::Reader< CMT >::Tpetra_MatrixMarket_Reader_Sl_CMT_Sg__readDenseFile__SWIG_0(std::string const &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::comm_type const > const &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > &,bool const,bool const)");; - try - { - // Attempt the wrapped function call - result = Tpetra_MatrixMarket_Reader_Sl_CMT_Sg__readDenseFile__SWIG_0((std::string const &)*arg1,(Teuchos::RCP< Teuchos::Comm< int > const > const &)*arg2,*arg3,arg4,arg5); - } - catch (const std::range_error& e) - { - // Store a C++ exception - SWIG_exception_impl("Tpetra::MatrixMarket::Reader< CMT >::Tpetra_MatrixMarket_Reader_Sl_CMT_Sg__readDenseFile__SWIG_0(std::string const &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::comm_type const > const &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > &,bool const,bool const)", SWIG_IndexError, e.what(), return SwigClassWrapper_uninitialized()); - } - catch (const std::exception& e) - { - // Store a C++ exception - SWIG_exception_impl("Tpetra::MatrixMarket::Reader< CMT >::Tpetra_MatrixMarket_Reader_Sl_CMT_Sg__readDenseFile__SWIG_0(std::string const &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::comm_type const > const &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > &,bool const,bool const)", SWIG_RuntimeError, e.what(), return SwigClassWrapper_uninitialized()); - } - catch (...) - { - SWIG_exception_impl("Tpetra::MatrixMarket::Reader< CMT >::Tpetra_MatrixMarket_Reader_Sl_CMT_Sg__readDenseFile__SWIG_0(std::string const &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::comm_type const > const &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > &,bool const,bool const)", SWIG_UnknownError, "An unknown exception occurred", return SwigClassWrapper_uninitialized()); - } - } - fresult.cptr = (new Teuchos::RCP< Tpetra::MultiVector >(static_cast< const Teuchos::RCP< Tpetra::MultiVector >& >(result))); - fresult.mem = SWIG_MOVE; - return fresult; -} - - -SWIGEXPORT SwigClassWrapper _wrap_TpetraReader_readDenseFile__SWIG_1(SwigArrayWrapper *farg1, SwigClassWrapper const *farg2, SwigClassWrapper const *farg3, int const *farg4) { - SwigClassWrapper fresult ; - std::string *arg1 = 0 ; - Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::comm_type const > *arg2 = 0 ; - Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > *arg3 = 0 ; - bool arg4 ; - std::string tempstr1 ; - Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::comm_type const > tempnull2 ; - Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > tempnull3 ; - Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::multivector_type > result; - - tempstr1 = std::string(static_cast(farg1->data), farg1->size); - arg1 = &tempstr1; - arg2 = farg2->cptr ? static_cast< Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::comm_type const > * >(farg2->cptr) : &tempnull2; - arg3 = farg3->cptr ? static_cast< Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > * >(farg3->cptr) : &tempnull3; - arg4 = (*farg4 ? true : false); - { - // Make sure no unhandled exceptions exist before performing a new action - SWIG_check_unhandled_exception_impl("Tpetra::MatrixMarket::Reader< CMT >::Tpetra_MatrixMarket_Reader_Sl_CMT_Sg__readDenseFile__SWIG_0(std::string const &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::comm_type const > const &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > &,bool const)");; - try - { - // Attempt the wrapped function call - result = Tpetra_MatrixMarket_Reader_Sl_CMT_Sg__readDenseFile__SWIG_0((std::string const &)*arg1,(Teuchos::RCP< Teuchos::Comm< int > const > const &)*arg2,*arg3,arg4); - } - catch (const std::range_error& e) - { - // Store a C++ exception - SWIG_exception_impl("Tpetra::MatrixMarket::Reader< CMT >::Tpetra_MatrixMarket_Reader_Sl_CMT_Sg__readDenseFile__SWIG_0(std::string const &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::comm_type const > const &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > &,bool const)", SWIG_IndexError, e.what(), return SwigClassWrapper_uninitialized()); - } - catch (const std::exception& e) - { - // Store a C++ exception - SWIG_exception_impl("Tpetra::MatrixMarket::Reader< CMT >::Tpetra_MatrixMarket_Reader_Sl_CMT_Sg__readDenseFile__SWIG_0(std::string const &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::comm_type const > const &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > &,bool const)", SWIG_RuntimeError, e.what(), return SwigClassWrapper_uninitialized()); - } - catch (...) - { - SWIG_exception_impl("Tpetra::MatrixMarket::Reader< CMT >::Tpetra_MatrixMarket_Reader_Sl_CMT_Sg__readDenseFile__SWIG_0(std::string const &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::comm_type const > const &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > &,bool const)", SWIG_UnknownError, "An unknown exception occurred", return SwigClassWrapper_uninitialized()); - } - } - fresult.cptr = (new Teuchos::RCP< Tpetra::MultiVector >(static_cast< const Teuchos::RCP< Tpetra::MultiVector >& >(result))); - fresult.mem = SWIG_MOVE; - return fresult; -} - - -SWIGEXPORT SwigClassWrapper _wrap_TpetraReader_readDenseFile__SWIG_2(SwigArrayWrapper *farg1, SwigClassWrapper const *farg2, SwigClassWrapper const *farg3) { - SwigClassWrapper fresult ; - std::string *arg1 = 0 ; - Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::comm_type const > *arg2 = 0 ; - Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > *arg3 = 0 ; - std::string tempstr1 ; - Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::comm_type const > tempnull2 ; - Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > tempnull3 ; - Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::multivector_type > result; - - tempstr1 = std::string(static_cast(farg1->data), farg1->size); - arg1 = &tempstr1; - arg2 = farg2->cptr ? static_cast< Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::comm_type const > * >(farg2->cptr) : &tempnull2; - arg3 = farg3->cptr ? static_cast< Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > * >(farg3->cptr) : &tempnull3; - { - // Make sure no unhandled exceptions exist before performing a new action - SWIG_check_unhandled_exception_impl("Tpetra::MatrixMarket::Reader< CMT >::Tpetra_MatrixMarket_Reader_Sl_CMT_Sg__readDenseFile__SWIG_0(std::string const &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::comm_type const > const &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > &)");; - try - { - // Attempt the wrapped function call - result = Tpetra_MatrixMarket_Reader_Sl_CMT_Sg__readDenseFile__SWIG_0((std::string const &)*arg1,(Teuchos::RCP< Teuchos::Comm< int > const > const &)*arg2,*arg3); - } - catch (const std::range_error& e) - { - // Store a C++ exception - SWIG_exception_impl("Tpetra::MatrixMarket::Reader< CMT >::Tpetra_MatrixMarket_Reader_Sl_CMT_Sg__readDenseFile__SWIG_0(std::string const &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::comm_type const > const &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > &)", SWIG_IndexError, e.what(), return SwigClassWrapper_uninitialized()); - } - catch (const std::exception& e) - { - // Store a C++ exception - SWIG_exception_impl("Tpetra::MatrixMarket::Reader< CMT >::Tpetra_MatrixMarket_Reader_Sl_CMT_Sg__readDenseFile__SWIG_0(std::string const &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::comm_type const > const &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > &)", SWIG_RuntimeError, e.what(), return SwigClassWrapper_uninitialized()); - } - catch (...) - { - SWIG_exception_impl("Tpetra::MatrixMarket::Reader< CMT >::Tpetra_MatrixMarket_Reader_Sl_CMT_Sg__readDenseFile__SWIG_0(std::string const &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::comm_type const > const &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > &)", SWIG_UnknownError, "An unknown exception occurred", return SwigClassWrapper_uninitialized()); - } - } - fresult.cptr = (new Teuchos::RCP< Tpetra::MultiVector >(static_cast< const Teuchos::RCP< Tpetra::MultiVector >& >(result))); - fresult.mem = SWIG_MOVE; - return fresult; -} - - -SWIGEXPORT SwigClassWrapper _wrap_TpetraReader_readMapFile__SWIG_0(SwigArrayWrapper *farg1, SwigClassWrapper const *farg2, int const *farg3, int const *farg4) { - SwigClassWrapper fresult ; - std::string *arg1 = 0 ; - Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::comm_type const > *arg2 = 0 ; - bool arg3 ; - bool arg4 ; - std::string tempstr1 ; - Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::comm_type const > tempnull2 ; - Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > result; - - tempstr1 = std::string(static_cast(farg1->data), farg1->size); - arg1 = &tempstr1; - arg2 = farg2->cptr ? static_cast< Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::comm_type const > * >(farg2->cptr) : &tempnull2; - arg3 = (*farg3 ? true : false); - arg4 = (*farg4 ? true : false); - { - // Make sure no unhandled exceptions exist before performing a new action - SWIG_check_unhandled_exception_impl("Tpetra::MatrixMarket::Reader< CMT >::Tpetra_MatrixMarket_Reader_Sl_CMT_Sg__readMapFile__SWIG_0(std::string const &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::comm_type const > const &,bool const,bool const)");; - try - { - // Attempt the wrapped function call - result = Tpetra_MatrixMarket_Reader_Sl_CMT_Sg__readMapFile__SWIG_0((std::string const &)*arg1,(Teuchos::RCP< Teuchos::Comm< int > const > const &)*arg2,arg3,arg4); - } - catch (const std::range_error& e) - { - // Store a C++ exception - SWIG_exception_impl("Tpetra::MatrixMarket::Reader< CMT >::Tpetra_MatrixMarket_Reader_Sl_CMT_Sg__readMapFile__SWIG_0(std::string const &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::comm_type const > const &,bool const,bool const)", SWIG_IndexError, e.what(), return SwigClassWrapper_uninitialized()); - } - catch (const std::exception& e) - { - // Store a C++ exception - SWIG_exception_impl("Tpetra::MatrixMarket::Reader< CMT >::Tpetra_MatrixMarket_Reader_Sl_CMT_Sg__readMapFile__SWIG_0(std::string const &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::comm_type const > const &,bool const,bool const)", SWIG_RuntimeError, e.what(), return SwigClassWrapper_uninitialized()); - } - catch (...) - { - SWIG_exception_impl("Tpetra::MatrixMarket::Reader< CMT >::Tpetra_MatrixMarket_Reader_Sl_CMT_Sg__readMapFile__SWIG_0(std::string const &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::comm_type const > const &,bool const,bool const)", SWIG_UnknownError, "An unknown exception occurred", return SwigClassWrapper_uninitialized()); - } - } - fresult.cptr = (new Teuchos::RCP >(static_cast< const Teuchos::RCP >& >(result))); - fresult.mem = SWIG_MOVE; - return fresult; -} - - -SWIGEXPORT SwigClassWrapper _wrap_TpetraReader_readMapFile__SWIG_1(SwigArrayWrapper *farg1, SwigClassWrapper const *farg2, int const *farg3) { - SwigClassWrapper fresult ; - std::string *arg1 = 0 ; - Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::comm_type const > *arg2 = 0 ; - bool arg3 ; - std::string tempstr1 ; - Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::comm_type const > tempnull2 ; - Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > result; - - tempstr1 = std::string(static_cast(farg1->data), farg1->size); - arg1 = &tempstr1; - arg2 = farg2->cptr ? static_cast< Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::comm_type const > * >(farg2->cptr) : &tempnull2; - arg3 = (*farg3 ? true : false); - { - // Make sure no unhandled exceptions exist before performing a new action - SWIG_check_unhandled_exception_impl("Tpetra::MatrixMarket::Reader< CMT >::Tpetra_MatrixMarket_Reader_Sl_CMT_Sg__readMapFile__SWIG_0(std::string const &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::comm_type const > const &,bool const)");; - try - { - // Attempt the wrapped function call - result = Tpetra_MatrixMarket_Reader_Sl_CMT_Sg__readMapFile__SWIG_0((std::string const &)*arg1,(Teuchos::RCP< Teuchos::Comm< int > const > const &)*arg2,arg3); - } - catch (const std::range_error& e) - { - // Store a C++ exception - SWIG_exception_impl("Tpetra::MatrixMarket::Reader< CMT >::Tpetra_MatrixMarket_Reader_Sl_CMT_Sg__readMapFile__SWIG_0(std::string const &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::comm_type const > const &,bool const)", SWIG_IndexError, e.what(), return SwigClassWrapper_uninitialized()); - } - catch (const std::exception& e) - { - // Store a C++ exception - SWIG_exception_impl("Tpetra::MatrixMarket::Reader< CMT >::Tpetra_MatrixMarket_Reader_Sl_CMT_Sg__readMapFile__SWIG_0(std::string const &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::comm_type const > const &,bool const)", SWIG_RuntimeError, e.what(), return SwigClassWrapper_uninitialized()); - } - catch (...) - { - SWIG_exception_impl("Tpetra::MatrixMarket::Reader< CMT >::Tpetra_MatrixMarket_Reader_Sl_CMT_Sg__readMapFile__SWIG_0(std::string const &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::comm_type const > const &,bool const)", SWIG_UnknownError, "An unknown exception occurred", return SwigClassWrapper_uninitialized()); - } - } - fresult.cptr = (new Teuchos::RCP >(static_cast< const Teuchos::RCP >& >(result))); - fresult.mem = SWIG_MOVE; - return fresult; -} - - -SWIGEXPORT SwigClassWrapper _wrap_TpetraReader_readMapFile__SWIG_2(SwigArrayWrapper *farg1, SwigClassWrapper const *farg2) { - SwigClassWrapper fresult ; - std::string *arg1 = 0 ; - Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::comm_type const > *arg2 = 0 ; - std::string tempstr1 ; - Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::comm_type const > tempnull2 ; - Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::map_type const > result; - - tempstr1 = std::string(static_cast(farg1->data), farg1->size); - arg1 = &tempstr1; - arg2 = farg2->cptr ? static_cast< Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::comm_type const > * >(farg2->cptr) : &tempnull2; - { - // Make sure no unhandled exceptions exist before performing a new action - SWIG_check_unhandled_exception_impl("Tpetra::MatrixMarket::Reader< CMT >::Tpetra_MatrixMarket_Reader_Sl_CMT_Sg__readMapFile__SWIG_0(std::string const &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::comm_type const > const &)");; - try - { - // Attempt the wrapped function call - result = Tpetra_MatrixMarket_Reader_Sl_CMT_Sg__readMapFile__SWIG_0((std::string const &)*arg1,(Teuchos::RCP< Teuchos::Comm< int > const > const &)*arg2); - } - catch (const std::range_error& e) - { - // Store a C++ exception - SWIG_exception_impl("Tpetra::MatrixMarket::Reader< CMT >::Tpetra_MatrixMarket_Reader_Sl_CMT_Sg__readMapFile__SWIG_0(std::string const &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::comm_type const > const &)", SWIG_IndexError, e.what(), return SwigClassWrapper_uninitialized()); - } - catch (const std::exception& e) - { - // Store a C++ exception - SWIG_exception_impl("Tpetra::MatrixMarket::Reader< CMT >::Tpetra_MatrixMarket_Reader_Sl_CMT_Sg__readMapFile__SWIG_0(std::string const &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::comm_type const > const &)", SWIG_RuntimeError, e.what(), return SwigClassWrapper_uninitialized()); - } - catch (...) - { - SWIG_exception_impl("Tpetra::MatrixMarket::Reader< CMT >::Tpetra_MatrixMarket_Reader_Sl_CMT_Sg__readMapFile__SWIG_0(std::string const &,Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::comm_type const > const &)", SWIG_UnknownError, "An unknown exception occurred", return SwigClassWrapper_uninitialized()); - } - } - fresult.cptr = (new Teuchos::RCP >(static_cast< const Teuchos::RCP >& >(result))); - fresult.mem = SWIG_MOVE; - return fresult; -} - - -SWIGEXPORT SwigClassWrapper _wrap_new_TpetraReader() { - SwigClassWrapper fresult ; - Tpetra::MatrixMarket::Reader< CMT > *result = 0 ; - - { - // Make sure no unhandled exceptions exist before performing a new action - SWIG_check_unhandled_exception_impl("Tpetra::MatrixMarket::Reader< CMT >::Reader()");; - try - { - // Attempt the wrapped function call - result = (Tpetra::MatrixMarket::Reader< CMT > *)new Tpetra::MatrixMarket::Reader< CMT >(); - } - catch (const std::range_error& e) - { - // Store a C++ exception - SWIG_exception_impl("Tpetra::MatrixMarket::Reader< CMT >::Reader()", SWIG_IndexError, e.what(), return SwigClassWrapper_uninitialized()); - } - catch (const std::exception& e) - { - // Store a C++ exception - SWIG_exception_impl("Tpetra::MatrixMarket::Reader< CMT >::Reader()", SWIG_RuntimeError, e.what(), return SwigClassWrapper_uninitialized()); - } - catch (...) - { - SWIG_exception_impl("Tpetra::MatrixMarket::Reader< CMT >::Reader()", SWIG_UnknownError, "An unknown exception occurred", return SwigClassWrapper_uninitialized()); - } - } - fresult.cptr = result ? new Teuchos::RCP< Tpetra::MatrixMarket::Reader >(result SWIG_NO_NULL_DELETER_1) : NULL; - fresult.mem = SWIG_MOVE; - return fresult; -} - - -SWIGEXPORT void _wrap_delete_TpetraReader(SwigClassWrapper const *farg1) { - Tpetra::MatrixMarket::Reader< CMT > *arg1 = (Tpetra::MatrixMarket::Reader< CMT > *) 0 ; - Teuchos::RCP< Tpetra::MatrixMarket::Reader< CMT > > *smartarg1 ; - - smartarg1 = static_cast< Teuchos::RCP< Tpetra::MatrixMarket::Reader >* >(farg1->cptr); - arg1 = smartarg1 ? const_cast< Tpetra::MatrixMarket::Reader* >(smartarg1->get()) : NULL; - { - // Make sure no unhandled exceptions exist before performing a new action - SWIG_check_unhandled_exception_impl("Tpetra::MatrixMarket::Reader< CMT >::~Reader()");; - try - { - // Attempt the wrapped function call - (void)arg1; delete smartarg1; - } - catch (const std::range_error& e) - { - // Store a C++ exception - SWIG_exception_impl("Tpetra::MatrixMarket::Reader< CMT >::~Reader()", SWIG_IndexError, e.what(), return ); - } - catch (const std::exception& e) - { - // Store a C++ exception - SWIG_exception_impl("Tpetra::MatrixMarket::Reader< CMT >::~Reader()", SWIG_RuntimeError, e.what(), return ); - } - catch (...) - { - SWIG_exception_impl("Tpetra::MatrixMarket::Reader< CMT >::~Reader()", SWIG_UnknownError, "An unknown exception occurred", return ); - } - } - -} - - -SWIGEXPORT void _wrap_assign_TpetraReader(SwigClassWrapper * self, SwigClassWrapper const * other) { - typedef Teuchos::RCP< Tpetra::MatrixMarket::Reader > swig_lhs_classtype; - SWIG_assign(swig_lhs_classtype, self, - swig_lhs_classtype, const_cast(other), - 0 | swig::IS_DESTR | swig::IS_COPY_CONSTR); -} - - -SWIGEXPORT void _wrap_TpetraWriter_writeMapFile(SwigArrayWrapper *farg1, SwigClassWrapper const *farg2) { - std::string *arg1 = 0 ; - Tpetra::MatrixMarket::Writer< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > >::map_type *arg2 = 0 ; - std::string tempstr1 ; - Teuchos::RCP< Tpetra::Map< LO,GO,NO > const > *smartarg2 ; - - tempstr1 = std::string(static_cast(farg1->data), farg1->size); - arg1 = &tempstr1; - SWIG_check_sp_nonnull(farg2, "Tpetra::MatrixMarket::Writer< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > >::map_type *", "TpetraMap", "Tpetra::MatrixMarket::Writer< CMT >::writeMapFile(std::string const &,Tpetra::MatrixMarket::Writer< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > >::map_type const &)", return ) - smartarg2 = static_cast< Teuchos::RCP >* >(farg2->cptr); - arg2 = const_cast< Tpetra::Map* >(smartarg2->get()); - { - // Make sure no unhandled exceptions exist before performing a new action - SWIG_check_unhandled_exception_impl("Tpetra::MatrixMarket::Writer< CMT >::writeMapFile(std::string const &,Tpetra::MatrixMarket::Writer< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > >::map_type const &)");; - try - { - // Attempt the wrapped function call - Tpetra::MatrixMarket::Writer< CMT >::SWIGTEMPLATEDISAMBIGUATOR writeMapFile((std::string const &)*arg1,(Tpetra::Map< int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &)*arg2); - } - catch (const std::range_error& e) - { - // Store a C++ exception - SWIG_exception_impl("Tpetra::MatrixMarket::Writer< CMT >::writeMapFile(std::string const &,Tpetra::MatrixMarket::Writer< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > >::map_type const &)", SWIG_IndexError, e.what(), return ); - } - catch (const std::exception& e) - { - // Store a C++ exception - SWIG_exception_impl("Tpetra::MatrixMarket::Writer< CMT >::writeMapFile(std::string const &,Tpetra::MatrixMarket::Writer< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > >::map_type const &)", SWIG_RuntimeError, e.what(), return ); - } - catch (...) - { - SWIG_exception_impl("Tpetra::MatrixMarket::Writer< CMT >::writeMapFile(std::string const &,Tpetra::MatrixMarket::Writer< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > >::map_type const &)", SWIG_UnknownError, "An unknown exception occurred", return ); - } - } - -} - - -SWIGEXPORT void _wrap_TpetraWriter_writeSparseFile__SWIG_0(SwigArrayWrapper *farg1, SwigClassWrapper const *farg2, SwigArrayWrapper *farg3, SwigArrayWrapper *farg4, int const *farg5) { - std::string *arg1 = 0 ; - Teuchos::RCP< Tpetra::MatrixMarket::Writer< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > >::sparse_matrix_type const > *arg2 = 0 ; - std::string *arg3 = 0 ; - std::string *arg4 = 0 ; - bool arg5 ; - std::string tempstr1 ; - Teuchos::RCP< Tpetra::MatrixMarket::Writer< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > >::sparse_matrix_type const > tempnull2 ; - std::string tempstr3 ; - std::string tempstr4 ; - - tempstr1 = std::string(static_cast(farg1->data), farg1->size); - arg1 = &tempstr1; - arg2 = farg2->cptr ? static_cast< Teuchos::RCP< Tpetra::MatrixMarket::Writer< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > >::sparse_matrix_type const > * >(farg2->cptr) : &tempnull2; - tempstr3 = std::string(static_cast(farg3->data), farg3->size); - arg3 = &tempstr3; - tempstr4 = std::string(static_cast(farg4->data), farg4->size); - arg4 = &tempstr4; - arg5 = (*farg5 ? true : false); - { - // Make sure no unhandled exceptions exist before performing a new action - SWIG_check_unhandled_exception_impl("Tpetra::MatrixMarket::Writer< CMT >::Tpetra_MatrixMarket_Writer_Sl_CMT_Sg__writeSparseFile__SWIG_0(std::string const &,Teuchos::RCP< Tpetra::MatrixMarket::Writer< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > >::sparse_matrix_type const > const &,std::string const &,std::string const &,bool const)");; - try - { - // Attempt the wrapped function call - Tpetra_MatrixMarket_Writer_Sl_CMT_Sg__writeSparseFile__SWIG_0((std::string const &)*arg1,(Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const > const &)*arg2,(std::string const &)*arg3,(std::string const &)*arg4,arg5); - } - catch (const std::range_error& e) - { - // Store a C++ exception - SWIG_exception_impl("Tpetra::MatrixMarket::Writer< CMT >::Tpetra_MatrixMarket_Writer_Sl_CMT_Sg__writeSparseFile__SWIG_0(std::string const &,Teuchos::RCP< Tpetra::MatrixMarket::Writer< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > >::sparse_matrix_type const > const &,std::string const &,std::string const &,bool const)", SWIG_IndexError, e.what(), return ); - } - catch (const std::exception& e) - { - // Store a C++ exception - SWIG_exception_impl("Tpetra::MatrixMarket::Writer< CMT >::Tpetra_MatrixMarket_Writer_Sl_CMT_Sg__writeSparseFile__SWIG_0(std::string const &,Teuchos::RCP< Tpetra::MatrixMarket::Writer< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > >::sparse_matrix_type const > const &,std::string const &,std::string const &,bool const)", SWIG_RuntimeError, e.what(), return ); - } - catch (...) - { - SWIG_exception_impl("Tpetra::MatrixMarket::Writer< CMT >::Tpetra_MatrixMarket_Writer_Sl_CMT_Sg__writeSparseFile__SWIG_0(std::string const &,Teuchos::RCP< Tpetra::MatrixMarket::Writer< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > >::sparse_matrix_type const > const &,std::string const &,std::string const &,bool const)", SWIG_UnknownError, "An unknown exception occurred", return ); - } - } - -} - - -SWIGEXPORT void _wrap_TpetraWriter_writeSparseFile__SWIG_1(SwigArrayWrapper *farg1, SwigClassWrapper const *farg2, SwigArrayWrapper *farg3, SwigArrayWrapper *farg4) { - std::string *arg1 = 0 ; - Teuchos::RCP< Tpetra::MatrixMarket::Writer< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > >::sparse_matrix_type const > *arg2 = 0 ; - std::string *arg3 = 0 ; - std::string *arg4 = 0 ; - std::string tempstr1 ; - Teuchos::RCP< Tpetra::MatrixMarket::Writer< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > >::sparse_matrix_type const > tempnull2 ; - std::string tempstr3 ; - std::string tempstr4 ; - - tempstr1 = std::string(static_cast(farg1->data), farg1->size); - arg1 = &tempstr1; - arg2 = farg2->cptr ? static_cast< Teuchos::RCP< Tpetra::MatrixMarket::Writer< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > >::sparse_matrix_type const > * >(farg2->cptr) : &tempnull2; - tempstr3 = std::string(static_cast(farg3->data), farg3->size); - arg3 = &tempstr3; - tempstr4 = std::string(static_cast(farg4->data), farg4->size); - arg4 = &tempstr4; - { - // Make sure no unhandled exceptions exist before performing a new action - SWIG_check_unhandled_exception_impl("Tpetra::MatrixMarket::Writer< CMT >::Tpetra_MatrixMarket_Writer_Sl_CMT_Sg__writeSparseFile__SWIG_0(std::string const &,Teuchos::RCP< Tpetra::MatrixMarket::Writer< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > >::sparse_matrix_type const > const &,std::string const &,std::string const &)");; - try - { - // Attempt the wrapped function call - Tpetra_MatrixMarket_Writer_Sl_CMT_Sg__writeSparseFile__SWIG_0((std::string const &)*arg1,(Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const > const &)*arg2,(std::string const &)*arg3,(std::string const &)*arg4); - } - catch (const std::range_error& e) - { - // Store a C++ exception - SWIG_exception_impl("Tpetra::MatrixMarket::Writer< CMT >::Tpetra_MatrixMarket_Writer_Sl_CMT_Sg__writeSparseFile__SWIG_0(std::string const &,Teuchos::RCP< Tpetra::MatrixMarket::Writer< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > >::sparse_matrix_type const > const &,std::string const &,std::string const &)", SWIG_IndexError, e.what(), return ); - } - catch (const std::exception& e) - { - // Store a C++ exception - SWIG_exception_impl("Tpetra::MatrixMarket::Writer< CMT >::Tpetra_MatrixMarket_Writer_Sl_CMT_Sg__writeSparseFile__SWIG_0(std::string const &,Teuchos::RCP< Tpetra::MatrixMarket::Writer< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > >::sparse_matrix_type const > const &,std::string const &,std::string const &)", SWIG_RuntimeError, e.what(), return ); - } - catch (...) - { - SWIG_exception_impl("Tpetra::MatrixMarket::Writer< CMT >::Tpetra_MatrixMarket_Writer_Sl_CMT_Sg__writeSparseFile__SWIG_0(std::string const &,Teuchos::RCP< Tpetra::MatrixMarket::Writer< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > >::sparse_matrix_type const > const &,std::string const &,std::string const &)", SWIG_UnknownError, "An unknown exception occurred", return ); - } - } - -} - - -SWIGEXPORT void _wrap_TpetraWriter_writeSparseFile__SWIG_2(SwigArrayWrapper *farg1, SwigClassWrapper const *farg2, int const *farg3) { - std::string *arg1 = 0 ; - Teuchos::RCP< Tpetra::MatrixMarket::Writer< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > >::sparse_matrix_type const > *arg2 = 0 ; - bool arg3 ; - std::string tempstr1 ; - Teuchos::RCP< Tpetra::MatrixMarket::Writer< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > >::sparse_matrix_type const > tempnull2 ; - - tempstr1 = std::string(static_cast(farg1->data), farg1->size); - arg1 = &tempstr1; - arg2 = farg2->cptr ? static_cast< Teuchos::RCP< Tpetra::MatrixMarket::Writer< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > >::sparse_matrix_type const > * >(farg2->cptr) : &tempnull2; - arg3 = (*farg3 ? true : false); - { - // Make sure no unhandled exceptions exist before performing a new action - SWIG_check_unhandled_exception_impl("Tpetra::MatrixMarket::Writer< CMT >::Tpetra_MatrixMarket_Writer_Sl_CMT_Sg__writeSparseFile__SWIG_2(std::string const &,Teuchos::RCP< Tpetra::MatrixMarket::Writer< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > >::sparse_matrix_type const > const &,bool const)");; - try - { - // Attempt the wrapped function call - Tpetra_MatrixMarket_Writer_Sl_CMT_Sg__writeSparseFile__SWIG_2((std::string const &)*arg1,(Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const > const &)*arg2,arg3); - } - catch (const std::range_error& e) - { - // Store a C++ exception - SWIG_exception_impl("Tpetra::MatrixMarket::Writer< CMT >::Tpetra_MatrixMarket_Writer_Sl_CMT_Sg__writeSparseFile__SWIG_2(std::string const &,Teuchos::RCP< Tpetra::MatrixMarket::Writer< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > >::sparse_matrix_type const > const &,bool const)", SWIG_IndexError, e.what(), return ); - } - catch (const std::exception& e) - { - // Store a C++ exception - SWIG_exception_impl("Tpetra::MatrixMarket::Writer< CMT >::Tpetra_MatrixMarket_Writer_Sl_CMT_Sg__writeSparseFile__SWIG_2(std::string const &,Teuchos::RCP< Tpetra::MatrixMarket::Writer< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > >::sparse_matrix_type const > const &,bool const)", SWIG_RuntimeError, e.what(), return ); - } - catch (...) - { - SWIG_exception_impl("Tpetra::MatrixMarket::Writer< CMT >::Tpetra_MatrixMarket_Writer_Sl_CMT_Sg__writeSparseFile__SWIG_2(std::string const &,Teuchos::RCP< Tpetra::MatrixMarket::Writer< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > >::sparse_matrix_type const > const &,bool const)", SWIG_UnknownError, "An unknown exception occurred", return ); - } - } - -} - - -SWIGEXPORT void _wrap_TpetraWriter_writeSparseFile__SWIG_3(SwigArrayWrapper *farg1, SwigClassWrapper const *farg2) { - std::string *arg1 = 0 ; - Teuchos::RCP< Tpetra::MatrixMarket::Writer< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > >::sparse_matrix_type const > *arg2 = 0 ; - std::string tempstr1 ; - Teuchos::RCP< Tpetra::MatrixMarket::Writer< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > >::sparse_matrix_type const > tempnull2 ; - - tempstr1 = std::string(static_cast(farg1->data), farg1->size); - arg1 = &tempstr1; - arg2 = farg2->cptr ? static_cast< Teuchos::RCP< Tpetra::MatrixMarket::Writer< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > >::sparse_matrix_type const > * >(farg2->cptr) : &tempnull2; - { - // Make sure no unhandled exceptions exist before performing a new action - SWIG_check_unhandled_exception_impl("Tpetra::MatrixMarket::Writer< CMT >::Tpetra_MatrixMarket_Writer_Sl_CMT_Sg__writeSparseFile__SWIG_2(std::string const &,Teuchos::RCP< Tpetra::MatrixMarket::Writer< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > >::sparse_matrix_type const > const &)");; - try - { - // Attempt the wrapped function call - Tpetra_MatrixMarket_Writer_Sl_CMT_Sg__writeSparseFile__SWIG_2((std::string const &)*arg1,(Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const > const &)*arg2); - } - catch (const std::range_error& e) - { - // Store a C++ exception - SWIG_exception_impl("Tpetra::MatrixMarket::Writer< CMT >::Tpetra_MatrixMarket_Writer_Sl_CMT_Sg__writeSparseFile__SWIG_2(std::string const &,Teuchos::RCP< Tpetra::MatrixMarket::Writer< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > >::sparse_matrix_type const > const &)", SWIG_IndexError, e.what(), return ); - } - catch (const std::exception& e) - { - // Store a C++ exception - SWIG_exception_impl("Tpetra::MatrixMarket::Writer< CMT >::Tpetra_MatrixMarket_Writer_Sl_CMT_Sg__writeSparseFile__SWIG_2(std::string const &,Teuchos::RCP< Tpetra::MatrixMarket::Writer< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > >::sparse_matrix_type const > const &)", SWIG_RuntimeError, e.what(), return ); - } - catch (...) - { - SWIG_exception_impl("Tpetra::MatrixMarket::Writer< CMT >::Tpetra_MatrixMarket_Writer_Sl_CMT_Sg__writeSparseFile__SWIG_2(std::string const &,Teuchos::RCP< Tpetra::MatrixMarket::Writer< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > >::sparse_matrix_type const > const &)", SWIG_UnknownError, "An unknown exception occurred", return ); - } - } - -} - - -SWIGEXPORT void _wrap_TpetraWriter_writeSparseGraphFile__SWIG_0(SwigArrayWrapper *farg1, SwigClassWrapper const *farg2, SwigArrayWrapper *farg3, SwigArrayWrapper *farg4, int const *farg5) { - std::string *arg1 = 0 ; - Teuchos::RCP< Tpetra::MatrixMarket::Writer< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > >::crs_graph_type const > *arg2 = 0 ; - std::string *arg3 = 0 ; - std::string *arg4 = 0 ; - bool arg5 ; - std::string tempstr1 ; - Teuchos::RCP< Tpetra::MatrixMarket::Writer< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > >::crs_graph_type const > tempnull2 ; - std::string tempstr3 ; - std::string tempstr4 ; - - tempstr1 = std::string(static_cast(farg1->data), farg1->size); - arg1 = &tempstr1; - arg2 = farg2->cptr ? static_cast< Teuchos::RCP< Tpetra::MatrixMarket::Writer< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > >::crs_graph_type const > * >(farg2->cptr) : &tempnull2; - tempstr3 = std::string(static_cast(farg3->data), farg3->size); - arg3 = &tempstr3; - tempstr4 = std::string(static_cast(farg4->data), farg4->size); - arg4 = &tempstr4; - arg5 = (*farg5 ? true : false); - { - // Make sure no unhandled exceptions exist before performing a new action - SWIG_check_unhandled_exception_impl("Tpetra::MatrixMarket::Writer< CMT >::Tpetra_MatrixMarket_Writer_Sl_CMT_Sg__writeSparseGraphFile__SWIG_0(std::string const &,Teuchos::RCP< Tpetra::MatrixMarket::Writer< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > >::crs_graph_type const > const &,std::string const &,std::string const &,bool const)");; - try - { - // Attempt the wrapped function call - Tpetra_MatrixMarket_Writer_Sl_CMT_Sg__writeSparseGraphFile__SWIG_0((std::string const &)*arg1,(Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const > const &)*arg2,(std::string const &)*arg3,(std::string const &)*arg4,arg5); - } - catch (const std::range_error& e) - { - // Store a C++ exception - SWIG_exception_impl("Tpetra::MatrixMarket::Writer< CMT >::Tpetra_MatrixMarket_Writer_Sl_CMT_Sg__writeSparseGraphFile__SWIG_0(std::string const &,Teuchos::RCP< Tpetra::MatrixMarket::Writer< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > >::crs_graph_type const > const &,std::string const &,std::string const &,bool const)", SWIG_IndexError, e.what(), return ); - } - catch (const std::exception& e) - { - // Store a C++ exception - SWIG_exception_impl("Tpetra::MatrixMarket::Writer< CMT >::Tpetra_MatrixMarket_Writer_Sl_CMT_Sg__writeSparseGraphFile__SWIG_0(std::string const &,Teuchos::RCP< Tpetra::MatrixMarket::Writer< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > >::crs_graph_type const > const &,std::string const &,std::string const &,bool const)", SWIG_RuntimeError, e.what(), return ); - } - catch (...) - { - SWIG_exception_impl("Tpetra::MatrixMarket::Writer< CMT >::Tpetra_MatrixMarket_Writer_Sl_CMT_Sg__writeSparseGraphFile__SWIG_0(std::string const &,Teuchos::RCP< Tpetra::MatrixMarket::Writer< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > >::crs_graph_type const > const &,std::string const &,std::string const &,bool const)", SWIG_UnknownError, "An unknown exception occurred", return ); - } - } - -} - - -SWIGEXPORT void _wrap_TpetraWriter_writeSparseGraphFile__SWIG_1(SwigArrayWrapper *farg1, SwigClassWrapper const *farg2, SwigArrayWrapper *farg3, SwigArrayWrapper *farg4) { - std::string *arg1 = 0 ; - Teuchos::RCP< Tpetra::MatrixMarket::Writer< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > >::crs_graph_type const > *arg2 = 0 ; - std::string *arg3 = 0 ; - std::string *arg4 = 0 ; - std::string tempstr1 ; - Teuchos::RCP< Tpetra::MatrixMarket::Writer< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > >::crs_graph_type const > tempnull2 ; - std::string tempstr3 ; - std::string tempstr4 ; - - tempstr1 = std::string(static_cast(farg1->data), farg1->size); - arg1 = &tempstr1; - arg2 = farg2->cptr ? static_cast< Teuchos::RCP< Tpetra::MatrixMarket::Writer< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > >::crs_graph_type const > * >(farg2->cptr) : &tempnull2; - tempstr3 = std::string(static_cast(farg3->data), farg3->size); - arg3 = &tempstr3; - tempstr4 = std::string(static_cast(farg4->data), farg4->size); - arg4 = &tempstr4; - { - // Make sure no unhandled exceptions exist before performing a new action - SWIG_check_unhandled_exception_impl("Tpetra::MatrixMarket::Writer< CMT >::Tpetra_MatrixMarket_Writer_Sl_CMT_Sg__writeSparseGraphFile__SWIG_0(std::string const &,Teuchos::RCP< Tpetra::MatrixMarket::Writer< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > >::crs_graph_type const > const &,std::string const &,std::string const &)");; - try - { - // Attempt the wrapped function call - Tpetra_MatrixMarket_Writer_Sl_CMT_Sg__writeSparseGraphFile__SWIG_0((std::string const &)*arg1,(Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const > const &)*arg2,(std::string const &)*arg3,(std::string const &)*arg4); - } - catch (const std::range_error& e) - { - // Store a C++ exception - SWIG_exception_impl("Tpetra::MatrixMarket::Writer< CMT >::Tpetra_MatrixMarket_Writer_Sl_CMT_Sg__writeSparseGraphFile__SWIG_0(std::string const &,Teuchos::RCP< Tpetra::MatrixMarket::Writer< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > >::crs_graph_type const > const &,std::string const &,std::string const &)", SWIG_IndexError, e.what(), return ); - } - catch (const std::exception& e) - { - // Store a C++ exception - SWIG_exception_impl("Tpetra::MatrixMarket::Writer< CMT >::Tpetra_MatrixMarket_Writer_Sl_CMT_Sg__writeSparseGraphFile__SWIG_0(std::string const &,Teuchos::RCP< Tpetra::MatrixMarket::Writer< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > >::crs_graph_type const > const &,std::string const &,std::string const &)", SWIG_RuntimeError, e.what(), return ); - } - catch (...) - { - SWIG_exception_impl("Tpetra::MatrixMarket::Writer< CMT >::Tpetra_MatrixMarket_Writer_Sl_CMT_Sg__writeSparseGraphFile__SWIG_0(std::string const &,Teuchos::RCP< Tpetra::MatrixMarket::Writer< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > >::crs_graph_type const > const &,std::string const &,std::string const &)", SWIG_UnknownError, "An unknown exception occurred", return ); - } - } - -} - - -SWIGEXPORT void _wrap_TpetraWriter_writeSparseGraphFile__SWIG_2(SwigArrayWrapper *farg1, SwigClassWrapper const *farg2, int const *farg3) { - std::string *arg1 = 0 ; - Teuchos::RCP< Tpetra::MatrixMarket::Writer< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > >::crs_graph_type const > *arg2 = 0 ; - bool arg3 ; - std::string tempstr1 ; - Teuchos::RCP< Tpetra::MatrixMarket::Writer< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > >::crs_graph_type const > tempnull2 ; - - tempstr1 = std::string(static_cast(farg1->data), farg1->size); - arg1 = &tempstr1; - arg2 = farg2->cptr ? static_cast< Teuchos::RCP< Tpetra::MatrixMarket::Writer< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > >::crs_graph_type const > * >(farg2->cptr) : &tempnull2; - arg3 = (*farg3 ? true : false); - { - // Make sure no unhandled exceptions exist before performing a new action - SWIG_check_unhandled_exception_impl("Tpetra::MatrixMarket::Writer< CMT >::Tpetra_MatrixMarket_Writer_Sl_CMT_Sg__writeSparseGraphFile__SWIG_2(std::string const &,Teuchos::RCP< Tpetra::MatrixMarket::Writer< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > >::crs_graph_type const > const &,bool const)");; - try - { - // Attempt the wrapped function call - Tpetra_MatrixMarket_Writer_Sl_CMT_Sg__writeSparseGraphFile__SWIG_2((std::string const &)*arg1,(Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const > const &)*arg2,arg3); - } - catch (const std::range_error& e) - { - // Store a C++ exception - SWIG_exception_impl("Tpetra::MatrixMarket::Writer< CMT >::Tpetra_MatrixMarket_Writer_Sl_CMT_Sg__writeSparseGraphFile__SWIG_2(std::string const &,Teuchos::RCP< Tpetra::MatrixMarket::Writer< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > >::crs_graph_type const > const &,bool const)", SWIG_IndexError, e.what(), return ); - } - catch (const std::exception& e) - { - // Store a C++ exception - SWIG_exception_impl("Tpetra::MatrixMarket::Writer< CMT >::Tpetra_MatrixMarket_Writer_Sl_CMT_Sg__writeSparseGraphFile__SWIG_2(std::string const &,Teuchos::RCP< Tpetra::MatrixMarket::Writer< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > >::crs_graph_type const > const &,bool const)", SWIG_RuntimeError, e.what(), return ); - } - catch (...) - { - SWIG_exception_impl("Tpetra::MatrixMarket::Writer< CMT >::Tpetra_MatrixMarket_Writer_Sl_CMT_Sg__writeSparseGraphFile__SWIG_2(std::string const &,Teuchos::RCP< Tpetra::MatrixMarket::Writer< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > >::crs_graph_type const > const &,bool const)", SWIG_UnknownError, "An unknown exception occurred", return ); - } - } - -} - - -SWIGEXPORT void _wrap_TpetraWriter_writeSparseGraphFile__SWIG_3(SwigArrayWrapper *farg1, SwigClassWrapper const *farg2) { - std::string *arg1 = 0 ; - Teuchos::RCP< Tpetra::MatrixMarket::Writer< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > >::crs_graph_type const > *arg2 = 0 ; - std::string tempstr1 ; - Teuchos::RCP< Tpetra::MatrixMarket::Writer< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > >::crs_graph_type const > tempnull2 ; - - tempstr1 = std::string(static_cast(farg1->data), farg1->size); - arg1 = &tempstr1; - arg2 = farg2->cptr ? static_cast< Teuchos::RCP< Tpetra::MatrixMarket::Writer< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > >::crs_graph_type const > * >(farg2->cptr) : &tempnull2; - { - // Make sure no unhandled exceptions exist before performing a new action - SWIG_check_unhandled_exception_impl("Tpetra::MatrixMarket::Writer< CMT >::Tpetra_MatrixMarket_Writer_Sl_CMT_Sg__writeSparseGraphFile__SWIG_2(std::string const &,Teuchos::RCP< Tpetra::MatrixMarket::Writer< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > >::crs_graph_type const > const &)");; - try - { - // Attempt the wrapped function call - Tpetra_MatrixMarket_Writer_Sl_CMT_Sg__writeSparseGraphFile__SWIG_2((std::string const &)*arg1,(Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const > const &)*arg2); - } - catch (const std::range_error& e) - { - // Store a C++ exception - SWIG_exception_impl("Tpetra::MatrixMarket::Writer< CMT >::Tpetra_MatrixMarket_Writer_Sl_CMT_Sg__writeSparseGraphFile__SWIG_2(std::string const &,Teuchos::RCP< Tpetra::MatrixMarket::Writer< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > >::crs_graph_type const > const &)", SWIG_IndexError, e.what(), return ); - } - catch (const std::exception& e) - { - // Store a C++ exception - SWIG_exception_impl("Tpetra::MatrixMarket::Writer< CMT >::Tpetra_MatrixMarket_Writer_Sl_CMT_Sg__writeSparseGraphFile__SWIG_2(std::string const &,Teuchos::RCP< Tpetra::MatrixMarket::Writer< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > >::crs_graph_type const > const &)", SWIG_RuntimeError, e.what(), return ); - } - catch (...) - { - SWIG_exception_impl("Tpetra::MatrixMarket::Writer< CMT >::Tpetra_MatrixMarket_Writer_Sl_CMT_Sg__writeSparseGraphFile__SWIG_2(std::string const &,Teuchos::RCP< Tpetra::MatrixMarket::Writer< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > >::crs_graph_type const > const &)", SWIG_UnknownError, "An unknown exception occurred", return ); - } - } - -} - - -SWIGEXPORT void _wrap_TpetraWriter_writeDenseFile__SWIG_0(SwigArrayWrapper *farg1, SwigClassWrapper const *farg2, SwigArrayWrapper *farg3, SwigArrayWrapper *farg4) { - std::string *arg1 = 0 ; - Teuchos::RCP< Tpetra::MatrixMarket::Writer< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > >::multivector_type const > *arg2 = 0 ; - std::string *arg3 = 0 ; - std::string *arg4 = 0 ; - std::string tempstr1 ; - Teuchos::RCP< Tpetra::MatrixMarket::Writer< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > >::multivector_type const > tempnull2 ; - std::string tempstr3 ; - std::string tempstr4 ; - - tempstr1 = std::string(static_cast(farg1->data), farg1->size); - arg1 = &tempstr1; - arg2 = farg2->cptr ? static_cast< Teuchos::RCP< Tpetra::MatrixMarket::Writer< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > >::multivector_type const > * >(farg2->cptr) : &tempnull2; - tempstr3 = std::string(static_cast(farg3->data), farg3->size); - arg3 = &tempstr3; - tempstr4 = std::string(static_cast(farg4->data), farg4->size); - arg4 = &tempstr4; - { - // Make sure no unhandled exceptions exist before performing a new action - SWIG_check_unhandled_exception_impl("Tpetra::MatrixMarket::Writer< CMT >::Tpetra_MatrixMarket_Writer_Sl_CMT_Sg__writeDenseFile__SWIG_0(std::string const &,Teuchos::RCP< Tpetra::MatrixMarket::Writer< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > >::multivector_type const > const &,std::string const &,std::string const &)");; - try - { - // Attempt the wrapped function call - Tpetra_MatrixMarket_Writer_Sl_CMT_Sg__writeDenseFile__SWIG_0((std::string const &)*arg1,(Teuchos::RCP< Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const > const &)*arg2,(std::string const &)*arg3,(std::string const &)*arg4); - } - catch (const std::range_error& e) - { - // Store a C++ exception - SWIG_exception_impl("Tpetra::MatrixMarket::Writer< CMT >::Tpetra_MatrixMarket_Writer_Sl_CMT_Sg__writeDenseFile__SWIG_0(std::string const &,Teuchos::RCP< Tpetra::MatrixMarket::Writer< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > >::multivector_type const > const &,std::string const &,std::string const &)", SWIG_IndexError, e.what(), return ); - } - catch (const std::exception& e) - { - // Store a C++ exception - SWIG_exception_impl("Tpetra::MatrixMarket::Writer< CMT >::Tpetra_MatrixMarket_Writer_Sl_CMT_Sg__writeDenseFile__SWIG_0(std::string const &,Teuchos::RCP< Tpetra::MatrixMarket::Writer< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > >::multivector_type const > const &,std::string const &,std::string const &)", SWIG_RuntimeError, e.what(), return ); - } - catch (...) - { - SWIG_exception_impl("Tpetra::MatrixMarket::Writer< CMT >::Tpetra_MatrixMarket_Writer_Sl_CMT_Sg__writeDenseFile__SWIG_0(std::string const &,Teuchos::RCP< Tpetra::MatrixMarket::Writer< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > >::multivector_type const > const &,std::string const &,std::string const &)", SWIG_UnknownError, "An unknown exception occurred", return ); + SWIG_exception_impl("Tpetra::MatrixMarket::Writer< Tpetra::CrsMatrix< SC,LO,GO,NO > >::writeDenseFile(std::string const &,Teuchos::RCP< Tpetra::MatrixMarket::Writer< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > >::multivector_type const > const &,std::string const &,std::string const &)", SWIG_UnknownError, "An unknown exception occurred", return ); } } @@ -15940,73 +14885,40 @@ SWIGEXPORT void _wrap_TpetraWriter_writeDenseFile__SWIG_1(SwigArrayWrapper *farg arg2 = farg2->cptr ? static_cast< Teuchos::RCP< Tpetra::MatrixMarket::Writer< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > >::multivector_type const > * >(farg2->cptr) : &tempnull2; { // Make sure no unhandled exceptions exist before performing a new action - SWIG_check_unhandled_exception_impl("Tpetra::MatrixMarket::Writer< CMT >::Tpetra_MatrixMarket_Writer_Sl_CMT_Sg__writeDenseFile__SWIG_1(std::string const &,Teuchos::RCP< Tpetra::MatrixMarket::Writer< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > >::multivector_type const > const &)");; + SWIG_check_unhandled_exception_impl("Tpetra::MatrixMarket::Writer< Tpetra::CrsMatrix< SC,LO,GO,NO > >::writeDenseFile(std::string const &,Teuchos::RCP< Tpetra::MatrixMarket::Writer< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > >::multivector_type const > const &)");; try { // Attempt the wrapped function call - Tpetra_MatrixMarket_Writer_Sl_CMT_Sg__writeDenseFile__SWIG_1((std::string const &)*arg1,(Teuchos::RCP< Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const > const &)*arg2); + Tpetra::MatrixMarket::Writer< Tpetra::CrsMatrix< SC,LO,GO,NO > >::SWIGTEMPLATEDISAMBIGUATOR writeDenseFile((std::string const &)*arg1,(Teuchos::RCP< Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const > const &)*arg2); } catch (const std::range_error& e) { // Store a C++ exception - SWIG_exception_impl("Tpetra::MatrixMarket::Writer< CMT >::Tpetra_MatrixMarket_Writer_Sl_CMT_Sg__writeDenseFile__SWIG_1(std::string const &,Teuchos::RCP< Tpetra::MatrixMarket::Writer< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > >::multivector_type const > const &)", SWIG_IndexError, e.what(), return ); + SWIG_exception_impl("Tpetra::MatrixMarket::Writer< Tpetra::CrsMatrix< SC,LO,GO,NO > >::writeDenseFile(std::string const &,Teuchos::RCP< Tpetra::MatrixMarket::Writer< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > >::multivector_type const > const &)", SWIG_IndexError, e.what(), return ); } catch (const std::exception& e) { // Store a C++ exception - SWIG_exception_impl("Tpetra::MatrixMarket::Writer< CMT >::Tpetra_MatrixMarket_Writer_Sl_CMT_Sg__writeDenseFile__SWIG_1(std::string const &,Teuchos::RCP< Tpetra::MatrixMarket::Writer< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > >::multivector_type const > const &)", SWIG_RuntimeError, e.what(), return ); + SWIG_exception_impl("Tpetra::MatrixMarket::Writer< Tpetra::CrsMatrix< SC,LO,GO,NO > >::writeDenseFile(std::string const &,Teuchos::RCP< Tpetra::MatrixMarket::Writer< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > >::multivector_type const > const &)", SWIG_RuntimeError, e.what(), return ); } catch (...) { - SWIG_exception_impl("Tpetra::MatrixMarket::Writer< CMT >::Tpetra_MatrixMarket_Writer_Sl_CMT_Sg__writeDenseFile__SWIG_1(std::string const &,Teuchos::RCP< Tpetra::MatrixMarket::Writer< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > >::multivector_type const > const &)", SWIG_UnknownError, "An unknown exception occurred", return ); + SWIG_exception_impl("Tpetra::MatrixMarket::Writer< Tpetra::CrsMatrix< SC,LO,GO,NO > >::writeDenseFile(std::string const &,Teuchos::RCP< Tpetra::MatrixMarket::Writer< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > >::multivector_type const > const &)", SWIG_UnknownError, "An unknown exception occurred", return ); } } } -SWIGEXPORT SwigClassWrapper _wrap_new_TpetraWriter() { - SwigClassWrapper fresult ; - Tpetra::MatrixMarket::Writer< CMT > *result = 0 ; - - { - // Make sure no unhandled exceptions exist before performing a new action - SWIG_check_unhandled_exception_impl("Tpetra::MatrixMarket::Writer< CMT >::Writer()");; - try - { - // Attempt the wrapped function call - result = (Tpetra::MatrixMarket::Writer< CMT > *)new Tpetra::MatrixMarket::Writer< CMT >(); - } - catch (const std::range_error& e) - { - // Store a C++ exception - SWIG_exception_impl("Tpetra::MatrixMarket::Writer< CMT >::Writer()", SWIG_IndexError, e.what(), return SwigClassWrapper_uninitialized()); - } - catch (const std::exception& e) - { - // Store a C++ exception - SWIG_exception_impl("Tpetra::MatrixMarket::Writer< CMT >::Writer()", SWIG_RuntimeError, e.what(), return SwigClassWrapper_uninitialized()); - } - catch (...) - { - SWIG_exception_impl("Tpetra::MatrixMarket::Writer< CMT >::Writer()", SWIG_UnknownError, "An unknown exception occurred", return SwigClassWrapper_uninitialized()); - } - } - fresult.cptr = result ? new Teuchos::RCP< Tpetra::MatrixMarket::Writer >(result SWIG_NO_NULL_DELETER_1) : NULL; - fresult.mem = SWIG_MOVE; - return fresult; -} - - SWIGEXPORT void _wrap_delete_TpetraWriter(SwigClassWrapper const *farg1) { - Tpetra::MatrixMarket::Writer< CMT > *arg1 = (Tpetra::MatrixMarket::Writer< CMT > *) 0 ; - Teuchos::RCP< Tpetra::MatrixMarket::Writer< CMT > > *smartarg1 ; + Tpetra::MatrixMarket::Writer< Tpetra::CrsMatrix< SC,LO,GO,NO > > *arg1 = (Tpetra::MatrixMarket::Writer< Tpetra::CrsMatrix< SC,LO,GO,NO > > *) 0 ; + Teuchos::RCP< Tpetra::MatrixMarket::Writer< Tpetra::CrsMatrix< SC,LO,GO,NO > > > *smartarg1 ; - smartarg1 = static_cast< Teuchos::RCP< Tpetra::MatrixMarket::Writer >* >(farg1->cptr); - arg1 = smartarg1 ? const_cast< Tpetra::MatrixMarket::Writer* >(smartarg1->get()) : NULL; + smartarg1 = static_cast< Teuchos::RCP< Tpetra::MatrixMarket::Writer > >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::MatrixMarket::Writer >* >(smartarg1->get()) : NULL; { // Make sure no unhandled exceptions exist before performing a new action - SWIG_check_unhandled_exception_impl("Tpetra::MatrixMarket::Writer< CMT >::~Writer()");; + SWIG_check_unhandled_exception_impl("Tpetra::MatrixMarket::Writer< Tpetra::CrsMatrix< SC,LO,GO,NO > >::~Writer()");; try { // Attempt the wrapped function call @@ -16015,16 +14927,16 @@ SWIGEXPORT void _wrap_delete_TpetraWriter(SwigClassWrapper const *farg1) { catch (const std::range_error& e) { // Store a C++ exception - SWIG_exception_impl("Tpetra::MatrixMarket::Writer< CMT >::~Writer()", SWIG_IndexError, e.what(), return ); + SWIG_exception_impl("Tpetra::MatrixMarket::Writer< Tpetra::CrsMatrix< SC,LO,GO,NO > >::~Writer()", SWIG_IndexError, e.what(), return ); } catch (const std::exception& e) { // Store a C++ exception - SWIG_exception_impl("Tpetra::MatrixMarket::Writer< CMT >::~Writer()", SWIG_RuntimeError, e.what(), return ); + SWIG_exception_impl("Tpetra::MatrixMarket::Writer< Tpetra::CrsMatrix< SC,LO,GO,NO > >::~Writer()", SWIG_RuntimeError, e.what(), return ); } catch (...) { - SWIG_exception_impl("Tpetra::MatrixMarket::Writer< CMT >::~Writer()", SWIG_UnknownError, "An unknown exception occurred", return ); + SWIG_exception_impl("Tpetra::MatrixMarket::Writer< Tpetra::CrsMatrix< SC,LO,GO,NO > >::~Writer()", SWIG_UnknownError, "An unknown exception occurred", return ); } } @@ -16032,7 +14944,7 @@ SWIGEXPORT void _wrap_delete_TpetraWriter(SwigClassWrapper const *farg1) { SWIGEXPORT void _wrap_assign_TpetraWriter(SwigClassWrapper * self, SwigClassWrapper const * other) { - typedef Teuchos::RCP< Tpetra::MatrixMarket::Writer > swig_lhs_classtype; + typedef Teuchos::RCP< Tpetra::MatrixMarket::Writer > > swig_lhs_classtype; SWIG_assign(swig_lhs_classtype, self, swig_lhs_classtype, const_cast(other), 0 | swig::IS_DESTR | swig::IS_COPY_CONSTR); From 4a05f372e10b48202846f84dae4b3ba9624e0a88 Mon Sep 17 00:00:00 2001 From: Seth R Johnson Date: Mon, 4 Feb 2019 11:44:52 -0500 Subject: [PATCH 23/40] Clean unused variables from tests --- src/interface/test/Tpetra_ModelEvaluator_1DFEM.F90 | 1 - src/tpetra/test/test_tpetra_crsgraph.F90 | 4 +--- src/tpetra/test/test_tpetra_multivector.F90 | 7 ------- src/tpetra/tutorials/PowerMethod.F90 | 2 +- 4 files changed, 2 insertions(+), 12 deletions(-) diff --git a/src/interface/test/Tpetra_ModelEvaluator_1DFEM.F90 b/src/interface/test/Tpetra_ModelEvaluator_1DFEM.F90 index d3384b24..0f9a1e07 100644 --- a/src/interface/test/Tpetra_ModelEvaluator_1DFEM.F90 +++ b/src/interface/test/Tpetra_ModelEvaluator_1DFEM.F90 @@ -139,7 +139,6 @@ function new_TpetraModelEvaluator1DFEM(comm, num_global_elems, z_min, z_max) & integer(global_ordinal_type) :: min_overlap_GID, gid integer(size_type) :: num_vecs=1 integer(global_ordinal_type), allocatable :: node_gids(:) - type(TpetraCrsGraph) :: graph ! ------------------------------------------------------------------------ ! self = ForModelEvaluator() diff --git a/src/tpetra/test/test_tpetra_crsgraph.F90 b/src/tpetra/test/test_tpetra_crsgraph.F90 index bc713573..4a55dc1e 100644 --- a/src/tpetra/test/test_tpetra_crsgraph.F90 +++ b/src/tpetra/test/test_tpetra_crsgraph.F90 @@ -217,7 +217,6 @@ program test_TpetraCrsGraph integer :: num_local integer(size_type), allocatable :: rowptr(:) integer, allocatable :: colind(:) - integer(global_ordinal_type), allocatable :: indices(:) OUT0("Starting TpetraCrsGraph_TwoArraysESFC!") @@ -305,9 +304,8 @@ program test_TpetraCrsGraph type(TpetraMap) :: map type(TpetraCrsGraph) :: Graph type(ParameterList) :: params - integer(size_type) :: kk, num_procs, nument + integer(size_type) :: kk, nument integer :: num_local - integer(size_type), allocatable :: rowptr(:) logical :: sorting_check integer(global_ordinal_type) :: j, jj, jstart, jfinish, firstind, lastind integer(global_ordinal_type), allocatable :: jinds(:) diff --git a/src/tpetra/test/test_tpetra_multivector.F90 b/src/tpetra/test/test_tpetra_multivector.F90 index c9ab3a20..cacc242f 100644 --- a/src/tpetra/test/test_tpetra_multivector.F90 +++ b/src/tpetra/test/test_tpetra_multivector.F90 @@ -56,15 +56,12 @@ program test_TpetraMultiVector ! -----------------------------ZeroScaleUpdate------------------------------ ! FORTRILINOS_UNIT_TEST(TpetraMultiVector_ZeroScaleUpdate) - integer :: i type(TpetraMap) :: map type(TpetraMultiVector) :: A, B, A2, C integer(size_type), parameter :: num_vecs=2, LDA=2 integer, parameter :: num_local=2 - integer :: lclrow logical :: zeroout real(scalar_type) :: norms(num_vecs), zeros(num_vecs), values(6) - integer(global_ordinal_type) :: gblrow, num_global zeros = 0.d0 @@ -271,7 +268,6 @@ program test_TpetraMultiVector ! ----------------------------------Abs------------------------------------- ! FORTRILINOS_UNIT_TEST(TpetraMultiVector_Abs) - integer :: i type(TpetraMap) :: map type(TpetraMultiVector) :: A, B, A2 integer(size_type), parameter :: num_vecs=2 @@ -310,7 +306,6 @@ program test_TpetraMultiVector character(kind=C_CHAR, len=:), allocatable :: description integer(size_type), parameter :: num_vecs=2 integer, parameter :: num_local=10 - integer(global_ordinal_type) :: num_global map = TpetraMap(TPETRA_GLOBAL_INVALID, num_local, comm); TEST_IERR() Vec = TpetraMultiVector(map, num_vecs) description = Vec%description(); TEST_IERR() @@ -356,7 +351,6 @@ program test_TpetraMultiVector type(TpetraMultiVector) :: mv3nx2, mv3nx3, mv2x2, mv2x3, mv3x2, mv3x3 real(scalar_type), parameter :: S0=0., S1=1. integer(int_type) :: num_images - integer(global_size_type) :: num_global real(scalar_type) :: check(9) OUT0("Starting Multiply") @@ -442,7 +436,6 @@ program test_TpetraMultiVector ! ----------------------------replaceGlobalValue---------------------------- ! FORTRILINOS_UNIT_TEST(TpetraMultiVector_ReplaceGlobalValue) - integer :: i type(TpetraMap) :: map type(TpetraMultiVector) :: Vec, OneV integer(size_type) :: col diff --git a/src/tpetra/tutorials/PowerMethod.F90 b/src/tpetra/tutorials/PowerMethod.F90 index 8b075778..17b063bf 100644 --- a/src/tpetra/tutorials/PowerMethod.F90 +++ b/src/tpetra/tutorials/PowerMethod.F90 @@ -38,7 +38,7 @@ program main integer :: my_rank integer(size_type) :: num_entries_in_row, max_entries_per_row, i integer :: lcl_row, row_nnz, n -integer :: num_my_elements, col, iconv +integer :: num_my_elements, iconv integer(global_ordinal_type) gbl_row, id_of_first_row ! -- Arrays From 86708c635717ac6feea7883ea20918f38a6945ed Mon Sep 17 00:00:00 2001 From: Seth R Johnson Date: Mon, 4 Feb 2019 13:40:28 -0500 Subject: [PATCH 24/40] Add output-on-failure flag to CTest --- docker/jenkins/build.sh | 2 +- 1 file changed, 1 insertion(+), 1 deletion(-) diff --git a/docker/jenkins/build.sh b/docker/jenkins/build.sh index 5768eff0..de35ed29 100755 --- a/docker/jenkins/build.sh +++ b/docker/jenkins/build.sh @@ -60,7 +60,7 @@ fi # build make -j"${NPROC}" -i # run the unit tests -ctest -j"${NPROC}" --no-compress-output -T Test +ctest -j"${NPROC}" --no-compress-output --output-on-failure -T Test # upload code coverage only once if [ "${BUILD_TYPE}" == "gcc54-mpi" ] then From f5d765911de9c83516d876ed2d6294e4e77d31c5 Mon Sep 17 00:00:00 2001 From: Seth R Johnson Date: Mon, 4 Feb 2019 15:25:24 -0500 Subject: [PATCH 25/40] Fix eigen_handle test and internal check --- src/interface/src/eigen_handle.cpp | 2 +- src/interface/test/test_eigen_handle.cpp | 2 +- src/interface/test/test_eigen_handle_preset.cpp | 2 +- 3 files changed, 3 insertions(+), 3 deletions(-) diff --git a/src/interface/src/eigen_handle.cpp b/src/interface/src/eigen_handle.cpp index efeb57c6..050f8fa3 100644 --- a/src/interface/src/eigen_handle.cpp +++ b/src/interface/src/eigen_handle.cpp @@ -148,7 +148,7 @@ namespace ForTrilinos { std::vector& eIndex = solution.index; size_t numConverged = std::min(eNum, numEigenvalues_); - TEUCHOS_TEST_FOR_EXCEPTION(eigenValues.size() < numConverged, std::runtime_error, + TEUCHOS_TEST_FOR_EXCEPTION(2 * eigenValues.size() < numConverged, std::runtime_error, "Insufficient space to store eigenvalues. Please provide at least two times the desired number of eigenvalues."); TEUCHOS_TEST_FOR_EXCEPTION(eigenIndex.size() < numConverged, std::runtime_error, "Insufficient space to store index. Please provide at least two times the desired number of eigenvalues."); diff --git a/src/interface/test/test_eigen_handle.cpp b/src/interface/test/test_eigen_handle.cpp index d5b5a5a5..0fef2fd3 100644 --- a/src/interface/test/test_eigen_handle.cpp +++ b/src/interface/test/test_eigen_handle.cpp @@ -75,7 +75,7 @@ int main(int argc, char *argv[]) { A->fillComplete(); // The eigen solution - std::vector evalues(1); + std::vector evalues(2); std::vector eindex(1); Teuchos::RCP X = Teuchos::rcp(new MultiVector(rowMap, 1)); diff --git a/src/interface/test/test_eigen_handle_preset.cpp b/src/interface/test/test_eigen_handle_preset.cpp index 37ec0293..b1f4b3ec 100644 --- a/src/interface/test/test_eigen_handle_preset.cpp +++ b/src/interface/test/test_eigen_handle_preset.cpp @@ -44,7 +44,7 @@ int main(int argc, char *argv[]) { auto M = Tpetra::MatrixMarket::Reader::readSparseFile("RHS_matrix.mat", comm); // The eigen solution - std::vector evalues(1); + std::vector evalues(2); std::vector eindex(1); Teuchos::RCP X = Teuchos::rcp(new MultiVector(A->getRowMap(), 1)); From fc13f684ec5ea6f137da39a32713fba0e7b4fd2d Mon Sep 17 00:00:00 2001 From: Seth R Johnson Date: Mon, 4 Feb 2019 15:49:27 -0500 Subject: [PATCH 26/40] Fix assignment from null array Not clear why this was working in GCC. Whenever a SWIG execption function fails, it returns an empty/null value, which in the case of a SwigArray is `{null, 0}`. It's unspecified behavior to do `c_f_pointer` with zero-sized arrays. GCC was somehow working, but flang chose to convert this result to a null fortran pointer, which then is *assigned* to `iarr` before the throw condition is checked. The solution is to have the test return pointers rather than automatically allocating arrays. --- src/teuchos/src/swig/forteuchos.F90 | 56 ++++++++++++++++++++++++- src/teuchos/test/test_teuchos_plist.F90 | 12 +++--- swig_hash | 2 +- 3 files changed, 61 insertions(+), 9 deletions(-) diff --git a/src/teuchos/src/swig/forteuchos.F90 b/src/teuchos/src/swig/forteuchos.F90 index 82f3e4a4..bec87902 100644 --- a/src/teuchos/src/swig/forteuchos.F90 +++ b/src/teuchos/src/swig/forteuchos.F90 @@ -621,9 +621,14 @@ function new_TeuchosArrayInt(arg0) & type(SwigClassWrapper) :: fresult type(SwigArrayWrapper) :: farg1 +if (size(arg0) > 0) then farg1_view => arg0(1) farg1%data = c_loc(farg1_view) farg1%size = size(arg0) +else +farg1%data = c_null_ptr +farg1%size = 0 +end if fresult = swigc_new_TeuchosArrayInt(farg1) self%swigdata = fresult end function @@ -639,7 +644,11 @@ function swigf_TeuchosArrayInt_view(self) & farg1 = self%swigdata fresult = swigc_TeuchosArrayInt_view(farg1) +if (fresult%size > 0) then call c_f_pointer(fresult%data, swig_result, [fresult%size]) +else +swig_result => NULL() +endif end function subroutine delete_TeuchosArrayInt(self) @@ -672,9 +681,14 @@ function new_TeuchosArrayDbl(arg0) & type(SwigClassWrapper) :: fresult type(SwigArrayWrapper) :: farg1 +if (size(arg0) > 0) then farg1_view => arg0(1) farg1%data = c_loc(farg1_view) farg1%size = size(arg0) +else +farg1%data = c_null_ptr +farg1%size = 0 +end if fresult = swigc_new_TeuchosArrayDbl(farg1) self%swigdata = fresult end function @@ -690,7 +704,11 @@ function swigf_TeuchosArrayDbl_view(self) & farg1 = self%swigdata fresult = swigc_TeuchosArrayDbl_view(farg1) +if (fresult%size > 0) then call c_f_pointer(fresult%data, swig_result, [fresult%size]) +else +swig_result => NULL() +endif end function subroutine delete_TeuchosArrayDbl(self) @@ -723,9 +741,14 @@ function new_TeuchosArrayLongLong(arg0) & type(SwigClassWrapper) :: fresult type(SwigArrayWrapper) :: farg1 +if (size(arg0) > 0) then farg1_view => arg0(1) farg1%data = c_loc(farg1_view) farg1%size = size(arg0) +else +farg1%data = c_null_ptr +farg1%size = 0 +end if fresult = swigc_new_TeuchosArrayLongLong(farg1) self%swigdata = fresult end function @@ -741,7 +764,11 @@ function swigf_TeuchosArrayLongLong_view(self) & farg1 = self%swigdata fresult = swigc_TeuchosArrayLongLong_view(farg1) +if (fresult%size > 0) then call c_f_pointer(fresult%data, swig_result, [fresult%size]) +else +swig_result => NULL() +endif end function subroutine delete_TeuchosArrayLongLong(self) @@ -1100,9 +1127,14 @@ subroutine swigf_ParameterList_set__SWIG_6(self, name, value) farg1 = self%swigdata call SWIG_string_to_chararray(name, farg2_chars, farg2) +if (size(value) > 0) then farg3_view => value(1) farg3%data = c_loc(farg3_view) farg3%size = size(value) +else +farg3%data = c_null_ptr +farg3%size = 0 +end if call swigc_ParameterList_set__SWIG_6(farg1, farg2, farg3) end subroutine @@ -1121,9 +1153,14 @@ subroutine swigf_ParameterList_set__SWIG_7(self, name, value) farg1 = self%swigdata call SWIG_string_to_chararray(name, farg2_chars, farg2) +if (size(value) > 0) then farg3_view => value(1) farg3%data = c_loc(farg3_view) farg3%size = size(value) +else +farg3%data = c_null_ptr +farg3%size = 0 +end if call swigc_ParameterList_set__SWIG_7(farg1, farg2, farg3) end subroutine @@ -1142,9 +1179,14 @@ subroutine swigf_ParameterList_set__SWIG_8(self, name, value) farg1 = self%swigdata call SWIG_string_to_chararray(name, farg2_chars, farg2) +if (size(value) > 0) then farg3_view => value(1) farg3%data = c_loc(farg3_view) farg3%size = size(value) +else +farg3%data = c_null_ptr +farg3%size = 0 +end if call swigc_ParameterList_set__SWIG_8(farg1, farg2, farg3) end subroutine @@ -1253,7 +1295,7 @@ subroutine SWIG_chararray_to_string(wrap, string) allocate(character(kind=C_CHAR, len=wrap%size) :: string) do i=1, wrap%size string(i:i) = chars(i) - enddo + end do end subroutine function swigf_ParameterList_get_string(self, name) & @@ -1291,7 +1333,11 @@ function swigf_ParameterList_get_arr_real(self, name) & farg1 = self%swigdata call SWIG_string_to_chararray(name, farg2_chars, farg2) fresult = swigc_ParameterList_get_arr_real(farg1, farg2) +if (fresult%size > 0) then call c_f_pointer(fresult%data, swig_result, [fresult%size]) +else +swig_result => NULL() +endif end function function swigf_ParameterList_get_arr_integer(self, name) & @@ -1310,7 +1356,11 @@ function swigf_ParameterList_get_arr_integer(self, name) & farg1 = self%swigdata call SWIG_string_to_chararray(name, farg2_chars, farg2) fresult = swigc_ParameterList_get_arr_integer(farg1, farg2) +if (fresult%size > 0) then call c_f_pointer(fresult%data, swig_result, [fresult%size]) +else +swig_result => NULL() +endif end function function swigf_ParameterList_get_arr_longlong(self, name) & @@ -1329,7 +1379,11 @@ function swigf_ParameterList_get_arr_longlong(self, name) & farg1 = self%swigdata call SWIG_string_to_chararray(name, farg2_chars, farg2) fresult = swigc_ParameterList_get_arr_longlong(farg1, farg2) +if (fresult%size > 0) then call c_f_pointer(fresult%data, swig_result, [fresult%size]) +else +swig_result => NULL() +endif end function subroutine delete_ParameterList(self) diff --git a/src/teuchos/test/test_teuchos_plist.F90 b/src/teuchos/test/test_teuchos_plist.F90 index d366efa0..35569a4c 100644 --- a/src/teuchos/test/test_teuchos_plist.F90 +++ b/src/teuchos/test/test_teuchos_plist.F90 @@ -27,8 +27,8 @@ program test_TeuchosPList integer(C_INT), dimension(6) :: test_int = (/ -1, 1, 3, 3, 5, 7 /) real(C_DOUBLE), dimension(4) :: test_dbl = (/ 0.1d0, 1.9d0, -2.0d0, 4.0d0 /) - integer(C_INT), allocatable :: iarr(:) - real(C_DOUBLE), allocatable :: darr(:) + integer(C_INT), pointer :: iarr(:) => NULL() + real(C_DOUBLE), pointer :: darr(:) => NULL() integer(C_INT) :: ival real(C_DOUBLE) :: dval logical :: bval @@ -63,13 +63,11 @@ program test_TeuchosPList ! FIXME: without these allocation, the test segfaults when compiled with flang ! According to [this](https://stackoverflow.com/questions/42140832/automatic-array-allocation-upon-assignment-in-fortran) it ! seems that it should be supported in F2003. So it is not clear why flang fails. - allocate(iarr(10)) - allocate(darr(10)) - iarr = plist%get_arr_integer('intarr') - darr = plist%get_arr_real('dblarr') + iarr => plist%get_arr_integer('intarr') + darr => plist%get_arr_real('dblarr') ! Wrong parameter type - TEST_THROW(iarr = plist%get_arr_integer('dblarr')) + TEST_THROW(iarr => plist%get_arr_integer('dblarr')) call plist%set('deleteme', 123) TEST_ASSERT(plist%is_parameter('deleteme')) diff --git a/swig_hash b/swig_hash index 8d9db618..bd3c048f 100644 --- a/swig_hash +++ b/swig_hash @@ -1 +1 @@ -a2f974dc4cc7ea7289ef3abb3c8bcbef03b96fef +eea2a05f6 From ad811a0af96845bd5b01dfa7fb1c37176b9556ac Mon Sep 17 00:00:00 2001 From: Tim Fuller Date: Mon, 12 Feb 2018 14:08:48 -0700 Subject: [PATCH 27/40] New test for broke TpetraCrsMatrix%getGlobalRowView Updated to latest SWIG. Currently fails to compile: ``` call A%getGlobalRowView(gblrow, cgview(1:nnz), csview(1:nnz)) 1 Error: Type mismatch in argument 'indices' at (1); passed INTEGER(8) to CLASS(swigtype_teuchos__arrayviewt_long_long_const_t) ``` --- src/tpetra/test/test_tpetra_crsmatrix.F90 | 145 ++++++++++++++++++---- 1 file changed, 122 insertions(+), 23 deletions(-) diff --git a/src/tpetra/test/test_tpetra_crsmatrix.F90 b/src/tpetra/test/test_tpetra_crsmatrix.F90 index 433deb10..54096db2 100644 --- a/src/tpetra/test/test_tpetra_crsmatrix.F90 +++ b/src/tpetra/test/test_tpetra_crsmatrix.F90 @@ -35,7 +35,7 @@ program test_TpetraCrsMatrix ! ADD_SUBTEST_AND_RUN(TpetraCrsMatrix_isStorageOptimized) ! ADD_SUBTEST_AND_RUN(TpetraCrsMatrix_isStaticGraph) ! ADD_SUBTEST_AND_RUN(TpetraCrsMatrix_supportsRowViews) -! ADD_SUBTEST_AND_RUN(TpetraCrsMatrix_getGlobalRowView) + ADD_SUBTEST_AND_RUN(TpetraCrsMatrix_getGlobalRowView) ! ADD_SUBTEST_AND_RUN(TpetraCrsMatrix_getLocalRowViewRaw) ! ADD_SUBTEST_AND_RUN(TpetraCrsMatrix_gaussSeidel) ! ADD_SUBTEST_AND_RUN(TpetraCrsMatrix_reorderedGaussSeidel) @@ -364,7 +364,7 @@ program test_TpetraCrsMatrix cols(1) = row; vals(1) = 0. call Mat%insertGlobalValues(row, cols, zeros); TEST_IERR() - params = ParameterList("ANONOMOUS") + params = ParameterList("ANONYMOUS") ! call params%set("Optimize Storage", .false.) ! FIXME: boolean parameters call Mat%fillComplete(params); TEST_ASSERT((.not. Mat%isFillActive())) @@ -402,7 +402,7 @@ program test_TpetraCrsMatrix ! FIXME: then the call to fillComplete below hangs indefinitely call Mat%insertGlobalValues(row, cols, vals); TEST_IERR() - params = ParameterList("ANONOMOUS"); TEST_IERR() + params = ParameterList("ANONYMOUS"); TEST_IERR() call Mat%fillComplete(params); TEST_IERR() TEST_ASSERT((.not. Mat%isFillActive())) TEST_ASSERT(Mat%isFillComplete()) @@ -452,7 +452,7 @@ program test_TpetraCrsMatrix row = 1; cols(1) = 1; vals(1) = 0. call Mat%insertLocalValues(row, cols, tuple(0)); TEST_IERR() - params = ParameterList("ANONOMOUS") + params = ParameterList("ANONYMOUS") ! call params%set("Optimize Storage", .false.) ! FIXME: boolean parameters call Mat%fillComplete(params); TEST_ASSERT((.not. Mat%isFillActive())) @@ -485,7 +485,7 @@ program test_TpetraCrsMatrix row = 1; cols(1) = 1; vals(1) = 0.d0; call Mat%insertLocalValues(row, cols, vals); TEST_IERR() - params = ParameterList("ANONOMOUS"); TEST_IERR() + params = ParameterList("ANONYMOUS"); TEST_IERR() !call params%set("Optimize Storage", .false.); TEST_IERR() ! FIXME: boolean parameters call Mat%fillComplete(params); TEST_IERR() TEST_ASSERT((.not. Mat%isFillActive())) @@ -586,33 +586,132 @@ program test_TpetraCrsMatrix OUT0("Finished TpetraCrsMatrix_supportsRowViews") END_FORTRILINOS_UNIT_TEST(TpetraCrsMatrix_supportsRowViews) +#endif ! -----------------------------getGlobalRowView----------------------------- ! - FORTRILINOS_UNIT_TEST(TpetraCrsMatrix_getGlobalRowView) - type(TpetraCrsMatrix) :: Obj - integer(global_ordinal_type) :: globalrow - !type(TeuchosArrayViewLongLongConst) :: indices - !type(TeuchosArrayViewDoubleConst) :: values - OUT0("Starting TpetraCrsMatrix_getGlobalRowView") + FORTRILINOS_UNIT_TEST(TpetraCrsMatrix_GetGlobalRowView) - success = .false. + type(TpetraMap) :: rowmap, colmap + type(TpetraCrsMatrix) :: A + type(ParameterList) :: params + integer(TpetraProfileType) :: pftype + integer(size_type) :: num_images, my_image_id, numentries + integer :: nnz + integer :: T, j + integer, parameter :: lclrow=1 + logical :: opt_storage + real(norm_type) :: norms(1) + real(scalar_type) :: scopy(4), csview(4) + integer :: lcopy(4), clview(4), i + integer(global_ordinal_type) :: gcopy(4), cgview(4) + integer(global_ordinal_type) :: gblrow + integer, allocatable :: linds(:) + integer(global_ordinal_type), allocatable :: ginds(:), mask(:) + real(scalar_type), allocatable :: values(:) + ! ------------------------------------------------------------------------ ! - globalrow = 0 - !indices = xxx(); TEST_IERR() - !values = xxx(); TEST_IERR() - !Obj = TpetraCrsMatrix(); TEST_IERR() - !call Obj%getGlobalRowView(globalrow, indices, values); TEST_IERR() + OUT0("Starting TpetraCrsMatrix_GetGlobalRowView") - !call indices%release(); TEST_IERR() - !call values%release(); TEST_IERR() - !call Obj%release(); TEST_IERR() + num_images = comm%getSize() + my_image_id = comm%getRank() + + if (num_images < 2) return - write(*,*) 'TpetraCrsMatrix_getGlobalRowView: Test not yet implemented' + ! create a Map, one row per processor + rowmap = TpetraMap(TPETRA_GLOBAL_INVALID, 1, comm); TEST_IERR() - OUT0("Finished TpetraCrsMatrix_getGlobalRowView") + gblrow = rowmap%getGlobalElement(1); + + ! specify the column map to control ordering + ! construct tridiagonal graph + if (gblrow == 1) then + nnz = 2 + allocate(ginds(nnz)); + ginds = [gblrow, gblrow+1] + else if (gblrow == num_images) then + nnz = 2 + allocate(ginds(nnz)); + ginds = [gblrow-1, gblrow] + else + nnz = 3 + allocate(ginds(nnz)); + ginds = [gblrow-1, gblrow, gblrow+1] + end if + allocate(linds(nnz)) + forall(i=1:nnz) linds(i)=i - END_FORTRILINOS_UNIT_TEST(TpetraCrsMatrix_getGlobalRowView) + allocate(values(nnz)) + values = 1.0d0 + ! Create column map + colmap = TpetraMap(TPETRA_GLOBAL_INVALID, ginds, comm); + + params = ParameterList("ANONYMOUS") + + do T = 0, 3 + if (IAND(T, 1) == 1) then + pftype = TpetraStaticProfile + else + pftype = TpetraDynamicProfile + endif + opt_storage = IAND(T, 2) == 2 + call params%set("Optimize Storage", opt_storage) + + ! only allocate as much room as necessary + numentries = int(nnz, kind=size_type) + A = TpetraCrsMatrix(rowmap, colmap, numentries, pftype) + + ! at this point, the graph has not allocated data as global or local, so + ! we can do views/copies for either local or global + call A%getLocalRowCopy(lclrow, lcopy, scopy, numentries) + !call A%getLocalRowView(lclrow, clview, csview) + call A%getGlobalRowCopy(gblrow, gcopy, scopy, numentries) + + call A%insertGlobalValues(gblrow, ginds, values) + + ! check values before calling fillComplete + allocate(mask(nnz)) + mask = -1 + call A%getGlobalRowView(gblrow, cgview(1:nnz), csview(1:nnz)) + do i=1, nnz; + where(ginds(i)==cgview) mask = i + end do + TEST_ASSERT((.not. any(mask==-1))) + TEST_ARRAY_EQUALITY(cgview(mask), ginds) + TEST_FLOATING_ARRAY_EQUALITY(csview(mask), values, epsilon(0.d0)) + deallocate(mask) + + call A%fillComplete(params); + + ! check for throws and no-throws/values + TEST_THROW(call A%getGlobalRowView(gblrow, cgview, csview)) + + !TEST_NOTHROW(call A%getLocalRowView(lclrow, clview, csview)) + !TEST_ARRAY_EQUALITY(clview, linds) + !TEST_FLOATING_ARRAY_EQUALITY(csview, values, epsilon(0.d0)) + + TEST_NOTHROW(call A%getLocalRowCopy(lclrow, lcopy, scopy, numentries)) + TEST_ARRAY_EQUALITY(lcopy(1:numentries), linds) + TEST_FLOATING_ARRAY_EQUALITY(scopy(1:numentries), values, epsilon(0.d0)) + + TEST_NOTHROW(call A%getGlobalRowCopy(gblrow, gcopy, scopy, numentries) ); + TEST_ARRAY_EQUALITY(gcopy(1:numentries), ginds) + TEST_FLOATING_ARRAY_EQUALITY(scopy(1:numentries), values, epsilon(0.d0)) + + call A%release() + + end do + + call rowmap%release() + call colmap%release() + + deallocate(linds); deallocate(ginds); deallocate(values) + + OUT0("Finished TpetraCrsMatrix_GetGlobalRowView") + + END_FORTRILINOS_UNIT_TEST(TpetraCrsMatrix_GetGlobalRowView) + +#if 0 ! ----------------------------getLocalRowViewRaw---------------------------- ! FORTRILINOS_UNIT_TEST(TpetraCrsMatrix_getLocalRowViewRaw) type(TpetraCrsMatrix) :: Obj From cb209b9debbe181885ff53401c18d33c33b0a1f6 Mon Sep 17 00:00:00 2001 From: Seth R Johnson Date: Wed, 6 Feb 2019 09:58:09 -0500 Subject: [PATCH 28/40] Implement getGlobalRowView using array pointers --- src/belos/src/swig/forbelos.F90 | 2 +- src/interface/src/swig/fortrilinos.F90 | 10 + src/teuchos/src/Teuchos_ArrayView.i | 35 +- .../src/swig/forteuchosFORTRAN_wrap.cxx | 18 +- src/tpetra/src/fortpetra.i | 10 +- src/tpetra/src/swig/fortpetra.F90 | 408 +++++++++++++++++- src/tpetra/src/swig/fortpetraFORTRAN_wrap.cxx | 222 +++++----- src/tpetra/test/test_tpetra_crsmatrix.F90 | 27 +- src/utils/src/swig/forerror.F90 | 2 +- swig_hash | 2 +- 10 files changed, 570 insertions(+), 166 deletions(-) diff --git a/src/belos/src/swig/forbelos.F90 b/src/belos/src/swig/forbelos.F90 index 3bc6ae64..4b3033dc 100644 --- a/src/belos/src/swig/forbelos.F90 +++ b/src/belos/src/swig/forbelos.F90 @@ -244,7 +244,7 @@ subroutine SWIG_chararray_to_string(wrap, string) allocate(character(kind=C_CHAR, len=wrap%size) :: string) do i=1, wrap%size string(i:i) = chars(i) - enddo + end do end subroutine function convertReturnTypeToString(result) & diff --git a/src/interface/src/swig/fortrilinos.F90 b/src/interface/src/swig/fortrilinos.F90 index 5aacbe7b..99709caa 100644 --- a/src/interface/src/swig/fortrilinos.F90 +++ b/src/interface/src/swig/fortrilinos.F90 @@ -796,13 +796,23 @@ function swigf_TrilinosEigenSolver_solve(self, eigenvalues, eigenvectors, eigeni type(SwigArrayWrapper) :: farg4 farg1 = self%swigdata +if (size(eigenvalues) > 0) then farg2_view => eigenvalues(1) farg2%data = c_loc(farg2_view) farg2%size = size(eigenvalues) +else +farg2%data = c_null_ptr +farg2%size = 0 +end if farg3 = eigenvectors%swigdata +if (size(eigenindex) > 0) then farg4_view => eigenindex(1) farg4%data = c_loc(farg4_view) farg4%size = size(eigenindex) +else +farg4%data = c_null_ptr +farg4%size = 0 +end if fresult = swigc_TrilinosEigenSolver_solve(farg1, farg2, farg3, farg4) swig_result = int(fresult) end function diff --git a/src/teuchos/src/Teuchos_ArrayView.i b/src/teuchos/src/Teuchos_ArrayView.i index 4ff4d72f..529384b2 100644 --- a/src/teuchos/src/Teuchos_ArrayView.i +++ b/src/teuchos/src/Teuchos_ArrayView.i @@ -17,6 +17,7 @@ class ArrayView { public: typedef _Tp value_type; + typedef _Tp* pointer; typedef std::size_t size_type; // Add native wrapping typemaps to convert to/from Teuchos array @@ -26,23 +27,33 @@ class ArrayView $1 = Teuchos::ArrayView<_Tp>(static_cast<_Tp*>($input->data), $input->size); } - %typemap(in, noblock=1) const ArrayView<_Tp> & (Teuchos::ArrayView<_Tp> tmparr) { - tmparr = Teuchos::ArrayView<_Tp>(static_cast<_Tp*>($input->data), $input->size); - $1 = &tmparr; - } - %typemap(out, noblock=1) ArrayView<_Tp> { $result.data = (void*)$1.getRawPtr(); $result.size = $1.size(); } - // XXX: %apply only works for *NAME-INSTANTIATED* types, not %template() - // types, so we have to manually copy these typemaps. - %typemap(ctype) const ArrayView<_Tp> & = ArrayView<_Tp>; - %typemap(imtype) const ArrayView<_Tp> & = ArrayView<_Tp>; - %typemap(ftype) const ArrayView<_Tp> & = ArrayView<_Tp>; - %typemap(fin) const ArrayView<_Tp> & = ArrayView<_Tp>; - %typemap(findecl) const ArrayView<_Tp> & = ArrayView<_Tp>; + %apply ArrayView<_Tp> { const ArrayView<_Tp> & } + + %typemap(in, noblock=1) const ArrayView<_Tp> & (Teuchos::ArrayView<_Tp> tmpview) { + tmpview = Teuchos::ArrayView<_Tp>(static_cast<_Tp*>($input->data), $input->size); + $1 = &tmpview; + } + %typemap(out, noblock=1) const ArrayView<_Tp>& { + $result.data = (void*)($1->getRawPtr()); + $result.size = $1->size(); + } + + // ...and by reference, modifying an incoming pointer + %fortran_array_handle(_Tp, ArrayView<_Tp>) + %typemap(in, noblock=1) ArrayView<_Tp>& (ArrayView<_Tp> tmpview) { + tmpview = $1_basetype(static_cast<$1_basetype::pointer>($input->data), $input->size); + $1 = &tmpview; + } + %typemap(argout, noblock=1, match="in") ArrayView<_Tp>& { + $input->data = (void*)tmpview$argnum.getRawPtr(); + $input->size = tmpview$argnum.size(); + } + }; } diff --git a/src/teuchos/src/swig/forteuchosFORTRAN_wrap.cxx b/src/teuchos/src/swig/forteuchosFORTRAN_wrap.cxx index b117b965..28a4912e 100644 --- a/src/teuchos/src/swig/forteuchosFORTRAN_wrap.cxx +++ b/src/teuchos/src/swig/forteuchosFORTRAN_wrap.cxx @@ -644,11 +644,11 @@ extern "C" { SWIGEXPORT SwigClassWrapper _wrap_new_TeuchosArrayInt(SwigArrayWrapper *farg1) { SwigClassWrapper fresult ; Teuchos::ArrayView< int const > *arg1 = 0 ; - Teuchos::ArrayView< int const > tmparr1 ; + Teuchos::ArrayView< int const > tmpview1 ; Teuchos::Array< int > *result = 0 ; - tmparr1 = Teuchos::ArrayView(static_cast(farg1->data), farg1->size); - arg1 = &tmparr1; + tmpview1 = Teuchos::ArrayView(static_cast(farg1->data), farg1->size); + arg1 = &tmpview1; { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Teuchos::Array< int >::Array(Teuchos::ArrayView< int const > const &)");; @@ -757,11 +757,11 @@ SWIGEXPORT void _wrap_assign_TeuchosArrayInt(SwigClassWrapper * self, SwigClassW SWIGEXPORT SwigClassWrapper _wrap_new_TeuchosArrayDbl(SwigArrayWrapper *farg1) { SwigClassWrapper fresult ; Teuchos::ArrayView< double const > *arg1 = 0 ; - Teuchos::ArrayView< double const > tmparr1 ; + Teuchos::ArrayView< double const > tmpview1 ; Teuchos::Array< double > *result = 0 ; - tmparr1 = Teuchos::ArrayView(static_cast(farg1->data), farg1->size); - arg1 = &tmparr1; + tmpview1 = Teuchos::ArrayView(static_cast(farg1->data), farg1->size); + arg1 = &tmpview1; { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Teuchos::Array< double >::Array(Teuchos::ArrayView< double const > const &)");; @@ -870,11 +870,11 @@ SWIGEXPORT void _wrap_assign_TeuchosArrayDbl(SwigClassWrapper * self, SwigClassW SWIGEXPORT SwigClassWrapper _wrap_new_TeuchosArrayLongLong(SwigArrayWrapper *farg1) { SwigClassWrapper fresult ; Teuchos::ArrayView< long long const > *arg1 = 0 ; - Teuchos::ArrayView< long long const > tmparr1 ; + Teuchos::ArrayView< long long const > tmpview1 ; Teuchos::Array< long long > *result = 0 ; - tmparr1 = Teuchos::ArrayView(static_cast(farg1->data), farg1->size); - arg1 = &tmparr1; + tmpview1 = Teuchos::ArrayView(static_cast(farg1->data), farg1->size); + arg1 = &tmpview1; { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Teuchos::Array< long long >::Array(Teuchos::ArrayView< long long const > const &)");; diff --git a/src/tpetra/src/fortpetra.i b/src/tpetra/src/fortpetra.i index d0895b02..0d22906a 100644 --- a/src/tpetra/src/fortpetra.i +++ b/src/tpetra/src/fortpetra.i @@ -89,12 +89,12 @@ public :: norm_type $1 = &tmpview; } -// *Return* by reference fortran indices. This modifies the return values after -// calling the wrapped C++ function. -%typemap(freearg, noblock=1) const Teuchos::ArrayView& INDEX +// Passing a *mutable* array view by const reference: increment the result +// before returning +%typemap(argout, noblock=1) const Teuchos::ArrayView& INDEX { - for (int i = 0; i < tmparr$argnum.size(); i++) - tmparr$argnum[i] += 1; + for (int i = 0; i < tmpview$argnum.size(); i++) + tmpview$argnum[i] += 1; } // ======================================================================= diff --git a/src/tpetra/src/swig/fortpetra.F90 b/src/tpetra/src/swig/fortpetra.F90 index 497fae75..72a5321a 100644 --- a/src/tpetra/src/swig/fortpetra.F90 +++ b/src/tpetra/src/swig/fortpetra.F90 @@ -475,12 +475,6 @@ module fortpetra type, public :: SWIGTYPE_KokkosSparse__CrsMatrixT_Tpetra__CrsMatrixT_doub1E12GN type(SwigClassWrapper), public :: swigdata end type - type, public :: SWIGTYPE_Teuchos__ArrayViewT_long_long_const_t - type(SwigClassWrapper), public :: swigdata - end type - type, public :: SWIGTYPE_Teuchos__ArrayViewT_double_const_t - type(SwigClassWrapper), public :: swigdata - end type ! class Tpetra::CrsMatrix< SC,LO,GO,NO > type, public :: TpetraCrsMatrix type(SwigClassWrapper), public :: swigdata @@ -3638,10 +3632,11 @@ subroutine swigc_TpetraCrsMatrix_getGlobalRowView(farg1, farg2, farg3, farg4) & bind(C, name="_wrap_TpetraCrsMatrix_getGlobalRowView") use, intrinsic :: ISO_C_BINDING import :: swigclasswrapper +import :: swigarraywrapper type(SwigClassWrapper) :: farg1 integer(C_LONG_LONG), intent(in) :: farg2 -type(SwigClassWrapper) :: farg3 -type(SwigClassWrapper) :: farg4 +type(SwigArrayWrapper) :: farg3 +type(SwigArrayWrapper) :: farg4 end subroutine subroutine swigc_TpetraCrsMatrix_apply__SWIG_0(farg1, farg2, farg3, farg4, farg5, farg6) & @@ -4374,7 +4369,7 @@ subroutine SWIG_chararray_to_string(wrap, string) allocate(character(kind=C_CHAR, len=wrap%size) :: string) do i=1, wrap%size string(i:i) = chars(i) - enddo + end do end subroutine function combineModeToString(combinemode) & @@ -4516,9 +4511,14 @@ function new_TpetraMap__SWIG_5(numglobalelements, indexlist, comm, node) & type(SwigClassWrapper) :: farg5 farg1 = numglobalelements +if (size(indexlist) > 0) then farg2_view => indexlist(1) farg2%data = c_loc(farg2_view) farg2%size = size(indexlist) +else +farg2%data = c_null_ptr +farg2%size = 0 +end if farg4 = comm%swigdata farg5 = node%swigdata fresult = swigc_new_TpetraMap__SWIG_5(farg1, farg2, farg4, farg5) @@ -4540,9 +4540,14 @@ function new_TpetraMap__SWIG_6(numglobalelements, indexlist, comm) & type(SwigClassWrapper) :: farg4 farg1 = numglobalelements +if (size(indexlist) > 0) then farg2_view => indexlist(1) farg2%data = c_loc(farg2_view) farg2%size = size(indexlist) +else +farg2%data = c_null_ptr +farg2%size = 0 +end if farg4 = comm%swigdata fresult = swigc_new_TpetraMap__SWIG_6(farg1, farg2, farg4) self%swigdata = fresult @@ -4768,15 +4773,30 @@ function swigf_TpetraMap_getRemoteIndexList__SWIG_0(self, gidlist, nodeidlist, l type(SwigArrayWrapper) :: farg4 farg1 = self%swigdata +if (size(gidlist) > 0) then farg2_view => gidlist(1) farg2%data = c_loc(farg2_view) farg2%size = size(gidlist) +else +farg2%data = c_null_ptr +farg2%size = 0 +end if +if (size(nodeidlist) > 0) then farg3_view => nodeidlist(1) farg3%data = c_loc(farg3_view) farg3%size = size(nodeidlist) +else +farg3%data = c_null_ptr +farg3%size = 0 +end if +if (size(lidlist) > 0) then farg4_view => lidlist(1) farg4%data = c_loc(farg4_view) farg4%size = size(lidlist) +else +farg4%data = c_null_ptr +farg4%size = 0 +end if fresult = swigc_TpetraMap_getRemoteIndexList__SWIG_0(farg1, farg2, farg3, farg4) swig_result = fresult end function @@ -4798,12 +4818,22 @@ function swigf_TpetraMap_getRemoteIndexList__SWIG_1(self, gidlist, nodeidlist) & type(SwigArrayWrapper) :: farg3 farg1 = self%swigdata +if (size(gidlist) > 0) then farg2_view => gidlist(1) farg2%data = c_loc(farg2_view) farg2%size = size(gidlist) +else +farg2%data = c_null_ptr +farg2%size = 0 +end if +if (size(nodeidlist) > 0) then farg3_view => nodeidlist(1) farg3%data = c_loc(farg3_view) farg3%size = size(nodeidlist) +else +farg3%data = c_null_ptr +farg3%size = 0 +end if fresult = swigc_TpetraMap_getRemoteIndexList__SWIG_1(farg1, farg2, farg3) swig_result = fresult end function @@ -4819,7 +4849,11 @@ function swigf_TpetraMap_getNodeElementList(self) & farg1 = self%swigdata fresult = swigc_TpetraMap_getNodeElementList(farg1) +if (fresult%size > 0) then call c_f_pointer(fresult%data, swig_result, [fresult%size]) +else +swig_result => NULL() +endif end function function swigf_TpetraMap_isNodeLocalElement(self, localindex) & @@ -5630,9 +5664,14 @@ function new_TpetraMultiVector__SWIG_5(map, a, lda, numvectors) & integer(C_SIZE_T) :: farg4 farg1 = map%swigdata +if (size(a) > 0) then farg2_view => a(1) farg2%data = c_loc(farg2_view) farg2%size = size(a) +else +farg2%data = c_null_ptr +farg2%size = 0 +end if farg3 = lda farg4 = numvectors fresult = swigc_new_TpetraMultiVector__SWIG_5(farg1, farg2, farg3, farg4) @@ -5912,9 +5951,14 @@ function swigf_TpetraMultiVector_subCopy(self, cols) & type(SwigArrayWrapper) :: farg2 farg1 = self%swigdata +if (size(cols) > 0) then farg2_view => cols(1) farg2%data = c_loc(farg2_view) farg2%size = size(cols) +else +farg2%data = c_null_ptr +farg2%size = 0 +end if fresult = swigc_TpetraMultiVector_subCopy(farg1, farg2) swig_result%swigdata = fresult end function @@ -5933,9 +5977,14 @@ function swigf_TpetraMultiVector_subView(self, cols) & type(SwigArrayWrapper) :: farg2 farg1 = self%swigdata +if (size(cols) > 0) then farg2_view => cols(1) farg2%data = c_loc(farg2_view) farg2%size = size(cols) +else +farg2%data = c_null_ptr +farg2%size = 0 +end if fresult = swigc_TpetraMultiVector_subView(farg1, farg2) swig_result%swigdata = fresult end function @@ -5954,9 +6003,14 @@ function swigf_TpetraMultiVector_subViewNonConst(self, cols) & type(SwigArrayWrapper) :: farg2 farg1 = self%swigdata +if (size(cols) > 0) then farg2_view => cols(1) farg2%data = c_loc(farg2_view) farg2%size = size(cols) +else +farg2%data = c_null_ptr +farg2%size = 0 +end if fresult = swigc_TpetraMultiVector_subViewNonConst(farg1, farg2) swig_result%swigdata = fresult end function @@ -6020,7 +6074,11 @@ function swigf_TpetraMultiVector_getData(self, j) & farg1 = self%swigdata farg2 = j fresult = swigc_TpetraMultiVector_getData(farg1, farg2) +if (fresult%size > 0) then call c_f_pointer(fresult%data, swig_result, [fresult%size]) +else +swig_result => NULL() +endif end function function swigf_TpetraMultiVector_getDataNonConst(self, j) & @@ -6038,7 +6096,11 @@ function swigf_TpetraMultiVector_getDataNonConst(self, j) & farg1 = self%swigdata farg2 = j fresult = swigc_TpetraMultiVector_getDataNonConst(farg1, farg2) +if (fresult%size > 0) then call c_f_pointer(fresult%data, swig_result, [fresult%size]) +else +swig_result => NULL() +endif end function subroutine swigf_TpetraMultiVector_get1dCopy(self, a, lda) @@ -6054,9 +6116,14 @@ subroutine swigf_TpetraMultiVector_get1dCopy(self, a, lda) integer(C_SIZE_T) :: farg3 farg1 = self%swigdata +if (size(a) > 0) then farg2_view => a(1) farg2%data = c_loc(farg2_view) farg2%size = size(a) +else +farg2%data = c_null_ptr +farg2%size = 0 +end if farg3 = lda call swigc_TpetraMultiVector_get1dCopy(farg1, farg2, farg3) end subroutine @@ -6072,7 +6139,11 @@ function swigf_TpetraMultiVector_get1dView(self) & farg1 = self%swigdata fresult = swigc_TpetraMultiVector_get1dView(farg1) +if (fresult%size > 0) then call c_f_pointer(fresult%data, swig_result, [fresult%size]) +else +swig_result => NULL() +endif end function function swigf_TpetraMultiVector_get1dViewNonConst(self) & @@ -6086,7 +6157,11 @@ function swigf_TpetraMultiVector_get1dViewNonConst(self) & farg1 = self%swigdata fresult = swigc_TpetraMultiVector_get1dViewNonConst(farg1) +if (fresult%size > 0) then call c_f_pointer(fresult%data, swig_result, [fresult%size]) +else +swig_result => NULL() +endif end function subroutine swigf_TpetraMultiVector_sync_host(self) @@ -6172,9 +6247,14 @@ subroutine swigf_TpetraMultiVector_dot__SWIG_0(self, a, dots) farg1 = self%swigdata farg2 = a%swigdata +if (size(dots) > 0) then farg3_view => dots(1) farg3%data = c_loc(farg3_view) farg3%size = size(dots) +else +farg3%data = c_null_ptr +farg3%size = 0 +end if call swigc_TpetraMultiVector_dot__SWIG_0(farg1, farg2, farg3) end subroutine @@ -6249,9 +6329,14 @@ subroutine swigf_TpetraMultiVector_scale__SWIG_1(self, alpha) type(SwigArrayWrapper) :: farg2 farg1 = self%swigdata +if (size(alpha) > 0) then farg2_view => alpha(1) farg2%data = c_loc(farg2_view) farg2%size = size(alpha) +else +farg2%data = c_null_ptr +farg2%size = 0 +end if call swigc_TpetraMultiVector_scale__SWIG_1(farg1, farg2) end subroutine @@ -6346,9 +6431,14 @@ subroutine swigf_TpetraMultiVector_norm1__SWIG_3(self, norms) type(SwigArrayWrapper) :: farg2 farg1 = self%swigdata +if (size(norms) > 0) then farg2_view => norms(1) farg2%data = c_loc(farg2_view) farg2%size = size(norms) +else +farg2%data = c_null_ptr +farg2%size = 0 +end if call swigc_TpetraMultiVector_norm1__SWIG_3(farg1, farg2) end subroutine @@ -6377,9 +6467,14 @@ subroutine swigf_TpetraMultiVector_norm2__SWIG_3(self, norms) type(SwigArrayWrapper) :: farg2 farg1 = self%swigdata +if (size(norms) > 0) then farg2_view => norms(1) farg2%data = c_loc(farg2_view) farg2%size = size(norms) +else +farg2%data = c_null_ptr +farg2%size = 0 +end if call swigc_TpetraMultiVector_norm2__SWIG_3(farg1, farg2) end subroutine @@ -6408,9 +6503,14 @@ subroutine swigf_TpetraMultiVector_normInf__SWIG_3(self, norms) type(SwigArrayWrapper) :: farg2 farg1 = self%swigdata +if (size(norms) > 0) then farg2_view => norms(1) farg2%data = c_loc(farg2_view) farg2%size = size(norms) +else +farg2%data = c_null_ptr +farg2%size = 0 +end if call swigc_TpetraMultiVector_normInf__SWIG_3(farg1, farg2) end subroutine @@ -6425,9 +6525,14 @@ subroutine swigf_TpetraMultiVector_meanValue(self, means) type(SwigArrayWrapper) :: farg2 farg1 = self%swigdata +if (size(means) > 0) then farg2_view => means(1) farg2%data = c_loc(farg2_view) farg2%size = size(means) +else +farg2%data = c_null_ptr +farg2%size = 0 +end if call swigc_TpetraMultiVector_meanValue(farg1, farg2) end subroutine @@ -7321,9 +7426,14 @@ subroutine swigf_TpetraCrsGraph_insertGlobalIndices__SWIG_0(self, globalrow, ind farg1 = self%swigdata farg2 = globalrow +if (size(indices) > 0) then farg3_view => indices(1) farg3%data = c_loc(farg3_view) farg3%size = size(indices) +else +farg3%data = c_null_ptr +farg3%size = 0 +end if call swigc_TpetraCrsGraph_insertGlobalIndices__SWIG_0(farg1, farg2, farg3) end subroutine @@ -7361,9 +7471,14 @@ subroutine swigf_TpetraCrsGraph_insertLocalIndices(self, localrow, indices) farg1 = self%swigdata farg2 = int(localrow, C_INT) +if (size(indices) > 0) then farg3_view => indices(1) farg3%data = c_loc(farg3_view) farg3%size = size(indices) +else +farg3%data = c_null_ptr +farg3%size = 0 +end if call swigc_TpetraCrsGraph_insertLocalIndices(farg1, farg2, farg3) end subroutine @@ -7999,9 +8114,14 @@ subroutine swigf_TpetraCrsGraph_getGlobalRowCopy(self, globalrow, indices, numin farg1 = self%swigdata farg2 = globalrow +if (size(indices) > 0) then farg3_view => indices(1) farg3%data = c_loc(farg3_view) farg3%size = size(indices) +else +farg3%data = c_null_ptr +farg3%size = 0 +end if farg4 = c_loc(numindices) call swigc_TpetraCrsGraph_getGlobalRowCopy(farg1, farg2, farg3, farg4) end subroutine @@ -8022,9 +8142,14 @@ subroutine swigf_TpetraCrsGraph_getLocalRowCopy(self, localrow, indices, numindi farg1 = self%swigdata farg2 = int(localrow, C_INT) +if (size(indices) > 0) then farg3_view => indices(1) farg3%data = c_loc(farg3_view) farg3%size = size(indices) +else +farg3%data = c_null_ptr +farg3%size = 0 +end if farg4 = c_loc(numindices) call swigc_TpetraCrsGraph_getLocalRowCopy(farg1, farg2, farg3, farg4) end subroutine @@ -8426,9 +8551,14 @@ function new_TpetraCrsGraph__SWIG_6(rowmap, numentperrow, pftype, params) & type(SwigClassWrapper) :: farg4 farg1 = rowmap%swigdata +if (size(numentperrow) > 0) then farg2_view => numentperrow(1) farg2%data = c_loc(farg2_view) farg2%size = size(numentperrow) +else +farg2%data = c_null_ptr +farg2%size = 0 +end if farg3 = pftype farg4 = params%swigdata fresult = swigc_new_TpetraCrsGraph__SWIG_6(farg1, farg2, farg3, farg4) @@ -8451,9 +8581,14 @@ function new_TpetraCrsGraph__SWIG_7(rowmap, numentperrow, pftype) & integer(C_INT) :: farg3 farg1 = rowmap%swigdata +if (size(numentperrow) > 0) then farg2_view => numentperrow(1) farg2%data = c_loc(farg2_view) farg2%size = size(numentperrow) +else +farg2%data = c_null_ptr +farg2%size = 0 +end if farg3 = pftype fresult = swigc_new_TpetraCrsGraph__SWIG_7(farg1, farg2, farg3) self%swigdata = fresult @@ -8473,9 +8608,14 @@ function new_TpetraCrsGraph__SWIG_8(rowmap, numentperrow) & type(SwigArrayWrapper) :: farg2 farg1 = rowmap%swigdata +if (size(numentperrow) > 0) then farg2_view => numentperrow(1) farg2%data = c_loc(farg2_view) farg2%size = size(numentperrow) +else +farg2%data = c_null_ptr +farg2%size = 0 +end if fresult = swigc_new_TpetraCrsGraph__SWIG_8(farg1, farg2) self%swigdata = fresult end function @@ -8502,9 +8642,14 @@ function new_TpetraCrsGraph__SWIG_9(rowmap, colmap, numentperrow, pftype, params farg1 = rowmap%swigdata farg2 = colmap%swigdata +if (size(numentperrow) > 0) then farg3_view => numentperrow(1) farg3%data = c_loc(farg3_view) farg3%size = size(numentperrow) +else +farg3%data = c_null_ptr +farg3%size = 0 +end if farg4 = pftype farg5 = params%swigdata fresult = swigc_new_TpetraCrsGraph__SWIG_9(farg1, farg2, farg3, farg4, farg5) @@ -8531,9 +8676,14 @@ function new_TpetraCrsGraph__SWIG_10(rowmap, colmap, numentperrow, pftype) & farg1 = rowmap%swigdata farg2 = colmap%swigdata +if (size(numentperrow) > 0) then farg3_view => numentperrow(1) farg3%data = c_loc(farg3_view) farg3%size = size(numentperrow) +else +farg3%data = c_null_ptr +farg3%size = 0 +end if farg4 = pftype fresult = swigc_new_TpetraCrsGraph__SWIG_10(farg1, farg2, farg3, farg4) self%swigdata = fresult @@ -8557,9 +8707,14 @@ function new_TpetraCrsGraph__SWIG_11(rowmap, colmap, numentperrow) & farg1 = rowmap%swigdata farg2 = colmap%swigdata +if (size(numentperrow) > 0) then farg3_view => numentperrow(1) farg3%data = c_loc(farg3_view) farg3%size = size(numentperrow) +else +farg3%data = c_null_ptr +farg3%size = 0 +end if fresult = swigc_new_TpetraCrsGraph__SWIG_11(farg1, farg2, farg3) self%swigdata = fresult end function @@ -8587,12 +8742,22 @@ function new_TpetraCrsGraph__SWIG_12(rowmap, colmap, rowpointers, columnindices, farg1 = rowmap%swigdata farg2 = colmap%swigdata +if (size(rowpointers) > 0) then farg3_view => rowpointers(1) farg3%data = c_loc(farg3_view) farg3%size = size(rowpointers) +else +farg3%data = c_null_ptr +farg3%size = 0 +end if +if (size(columnindices) > 0) then farg4_view => columnindices(1) farg4%data = c_loc(farg4_view) farg4%size = size(columnindices) +else +farg4%data = c_null_ptr +farg4%size = 0 +end if farg5 = params%swigdata fresult = swigc_new_TpetraCrsGraph__SWIG_12(farg1, farg2, farg3, farg4, farg5) self%swigdata = fresult @@ -8619,12 +8784,22 @@ function new_TpetraCrsGraph__SWIG_13(rowmap, colmap, rowpointers, columnindices) farg1 = rowmap%swigdata farg2 = colmap%swigdata +if (size(rowpointers) > 0) then farg3_view => rowpointers(1) farg3%data = c_loc(farg3_view) farg3%size = size(rowpointers) +else +farg3%data = c_null_ptr +farg3%size = 0 +end if +if (size(columnindices) > 0) then farg4_view => columnindices(1) farg4%data = c_loc(farg4_view) farg4%size = size(columnindices) +else +farg4%data = c_null_ptr +farg4%size = 0 +end if fresult = swigc_new_TpetraCrsGraph__SWIG_13(farg1, farg2, farg3, farg4) self%swigdata = fresult end function @@ -8640,9 +8815,14 @@ subroutine swigf_TpetraCrsGraph_getNodeRowPtrs(self, rowpointers) type(SwigArrayWrapper) :: farg2 farg1 = self%swigdata +if (size(rowpointers) > 0) then farg2_view => rowpointers(1) farg2%data = c_loc(farg2_view) farg2%size = size(rowpointers) +else +farg2%data = c_null_ptr +farg2%size = 0 +end if call swigc_TpetraCrsGraph_getNodeRowPtrs(farg1, farg2) end subroutine @@ -8657,9 +8837,14 @@ subroutine swigf_TpetraCrsGraph_getNodePackedIndices(self, columnindices) type(SwigArrayWrapper) :: farg2 farg1 = self%swigdata +if (size(columnindices) > 0) then farg2_view => columnindices(1) farg2%data = c_loc(farg2_view) farg2%size = size(columnindices) +else +farg2%data = c_null_ptr +farg2%size = 0 +end if call swigc_TpetraCrsGraph_getNodePackedIndices(farg1, farg2) end subroutine @@ -8998,12 +9183,22 @@ subroutine swigf_TpetraCrsMatrix_insertGlobalValues(self, globalrow, cols, vals) farg1 = self%swigdata farg2 = globalrow +if (size(cols) > 0) then farg3_view => cols(1) farg3%data = c_loc(farg3_view) farg3%size = size(cols) +else +farg3%data = c_null_ptr +farg3%size = 0 +end if +if (size(vals) > 0) then farg4_view => vals(1) farg4%data = c_loc(farg4_view) farg4%size = size(vals) +else +farg4%data = c_null_ptr +farg4%size = 0 +end if call swigc_TpetraCrsMatrix_insertGlobalValues(farg1, farg2, farg3, farg4) end subroutine @@ -9024,12 +9219,22 @@ subroutine swigf_TpetraCrsMatrix_insertLocalValues(self, localrow, cols, vals) farg1 = self%swigdata farg2 = int(localrow, C_INT) +if (size(cols) > 0) then farg3_view => cols(1) farg3%data = c_loc(farg3_view) farg3%size = size(cols) +else +farg3%data = c_null_ptr +farg3%size = 0 +end if +if (size(vals) > 0) then farg4_view => vals(1) farg4%data = c_loc(farg4_view) farg4%size = size(vals) +else +farg4%data = c_null_ptr +farg4%size = 0 +end if call swigc_TpetraCrsMatrix_insertLocalValues(farg1, farg2, farg3, farg4) end subroutine @@ -9053,12 +9258,22 @@ function swigf_TpetraCrsMatrix_replaceGlobalValues(self, globalrow, cols, vals) farg1 = self%swigdata farg2 = globalrow +if (size(cols) > 0) then farg3_view => cols(1) farg3%data = c_loc(farg3_view) farg3%size = size(cols) +else +farg3%data = c_null_ptr +farg3%size = 0 +end if +if (size(vals) > 0) then farg4_view => vals(1) farg4%data = c_loc(farg4_view) farg4%size = size(vals) +else +farg4%data = c_null_ptr +farg4%size = 0 +end if fresult = swigc_TpetraCrsMatrix_replaceGlobalValues(farg1, farg2, farg3, farg4) swig_result = int(fresult) end function @@ -9083,12 +9298,22 @@ function swigf_TpetraCrsMatrix_replaceLocalValues__SWIG_1(self, localrow, cols, farg1 = self%swigdata farg2 = int(localrow, C_INT) +if (size(cols) > 0) then farg3_view => cols(1) farg3%data = c_loc(farg3_view) farg3%size = size(cols) +else +farg3%data = c_null_ptr +farg3%size = 0 +end if +if (size(vals) > 0) then farg4_view => vals(1) farg4%data = c_loc(farg4_view) farg4%size = size(vals) +else +farg4%data = c_null_ptr +farg4%size = 0 +end if fresult = swigc_TpetraCrsMatrix_replaceLocalValues__SWIG_1(farg1, farg2, farg3, farg4) swig_result = int(fresult) end function @@ -9140,12 +9365,22 @@ function swigf_TpetraCrsMatrix_sumIntoGlobalValues__SWIG_0(self, globalrow, cols farg1 = self%swigdata farg2 = globalrow +if (size(cols) > 0) then farg3_view => cols(1) farg3%data = c_loc(farg3_view) farg3%size = size(cols) +else +farg3%data = c_null_ptr +farg3%size = 0 +end if +if (size(vals) > 0) then farg4_view => vals(1) farg4%data = c_loc(farg4_view) farg4%size = size(vals) +else +farg4%data = c_null_ptr +farg4%size = 0 +end if fresult = swigc_TpetraCrsMatrix_sumIntoGlobalValues__SWIG_0(farg1, farg2, farg3, farg4) swig_result = int(fresult) end function @@ -9170,12 +9405,22 @@ function swigf_TpetraCrsMatrix_sumIntoLocalValues__SWIG_0(self, localrow, cols, farg1 = self%swigdata farg2 = int(localrow, C_INT) +if (size(cols) > 0) then farg3_view => cols(1) farg3%data = c_loc(farg3_view) farg3%size = size(cols) +else +farg3%data = c_null_ptr +farg3%size = 0 +end if +if (size(vals) > 0) then farg4_view => vals(1) farg4%data = c_loc(farg4_view) farg4%size = size(vals) +else +farg4%data = c_null_ptr +farg4%size = 0 +end if fresult = swigc_TpetraCrsMatrix_sumIntoLocalValues__SWIG_0(farg1, farg2, farg3, farg4) swig_result = int(fresult) end function @@ -9877,12 +10122,22 @@ subroutine swigf_TpetraCrsMatrix_getGlobalRowCopy(self, globalrow, indices, valu farg1 = self%swigdata farg2 = globalrow +if (size(indices) > 0) then farg3_view => indices(1) farg3%data = c_loc(farg3_view) farg3%size = size(indices) +else +farg3%data = c_null_ptr +farg3%size = 0 +end if +if (size(values) > 0) then farg4_view => values(1) farg4%data = c_loc(farg4_view) farg4%size = size(values) +else +farg4%data = c_null_ptr +farg4%size = 0 +end if farg5 = c_loc(numentries) call swigc_TpetraCrsMatrix_getGlobalRowCopy(farg1, farg2, farg3, farg4, farg5) end subroutine @@ -9906,12 +10161,22 @@ subroutine swigf_TpetraCrsMatrix_getLocalRowCopy(self, localrow, colinds, vals, farg1 = self%swigdata farg2 = int(localrow, C_INT) +if (size(colinds) > 0) then farg3_view => colinds(1) farg3%data = c_loc(farg3_view) farg3%size = size(colinds) +else +farg3%data = c_null_ptr +farg3%size = 0 +end if +if (size(vals) > 0) then farg4_view => vals(1) farg4%data = c_loc(farg4_view) farg4%size = size(vals) +else +farg4%data = c_null_ptr +farg4%size = 0 +end if farg5 = c_loc(numentries) call swigc_TpetraCrsMatrix_getLocalRowCopy(farg1, farg2, farg3, farg4, farg5) end subroutine @@ -9921,20 +10186,41 @@ subroutine swigf_TpetraCrsMatrix_getGlobalRowView(self, globalrow, indices, valu class(TpetraCrsMatrix), intent(in) :: self integer(C_LONG_LONG), intent(in) :: globalrow -class(SWIGTYPE_Teuchos__ArrayViewT_long_long_const_t), intent(inout) :: indices - -class(SWIGTYPE_Teuchos__ArrayViewT_double_const_t), intent(inout) :: values +integer(C_LONG_LONG), dimension(:), pointer, intent(inout) :: indices +real(C_DOUBLE), dimension(:), pointer, intent(inout) :: values type(SwigClassWrapper) :: farg1 integer(C_LONG_LONG) :: farg2 -type(SwigClassWrapper) :: farg3 -type(SwigClassWrapper) :: farg4 +type(SwigArrayWrapper) :: farg3 +type(SwigArrayWrapper) :: farg4 farg1 = self%swigdata farg2 = globalrow -farg3 = indices%swigdata -farg4 = values%swigdata +if (size(indices) > 0) then +farg3%data = c_loc(indices) +farg3%size = size(indices) +else +farg3%data = c_null_ptr +farg3%size = 0 +end if +if (size(values) > 0) then +farg4%data = c_loc(values) +farg4%size = size(values) +else +farg4%data = c_null_ptr +farg4%size = 0 +end if call swigc_TpetraCrsMatrix_getGlobalRowView(farg1, farg2, farg3, farg4) +if (farg3%size > 0) then +call c_f_pointer(farg3%data, indices, [farg3%size]) +else +indices => NULL() +endif +if (farg4%size > 0) then +call c_f_pointer(farg4%data, values, [farg4%size]) +else +values => NULL() +endif end subroutine subroutine swigf_TpetraCrsMatrix_apply__SWIG_0(self, x, y, mode, alpha, beta) @@ -10418,9 +10704,14 @@ function new_TpetraCrsMatrix__SWIG_10(rowmap, numentriesperrowtoalloc, pftype, p type(SwigClassWrapper) :: farg4 farg1 = rowmap%swigdata +if (size(numentriesperrowtoalloc) > 0) then farg2_view => numentriesperrowtoalloc(1) farg2%data = c_loc(farg2_view) farg2%size = size(numentriesperrowtoalloc) +else +farg2%data = c_null_ptr +farg2%size = 0 +end if farg3 = pftype farg4 = params%swigdata fresult = swigc_new_TpetraCrsMatrix__SWIG_10(farg1, farg2, farg3, farg4) @@ -10443,9 +10734,14 @@ function new_TpetraCrsMatrix__SWIG_11(rowmap, numentriesperrowtoalloc, pftype) & integer(C_INT) :: farg3 farg1 = rowmap%swigdata +if (size(numentriesperrowtoalloc) > 0) then farg2_view => numentriesperrowtoalloc(1) farg2%data = c_loc(farg2_view) farg2%size = size(numentriesperrowtoalloc) +else +farg2%data = c_null_ptr +farg2%size = 0 +end if farg3 = pftype fresult = swigc_new_TpetraCrsMatrix__SWIG_11(farg1, farg2, farg3) self%swigdata = fresult @@ -10465,9 +10761,14 @@ function new_TpetraCrsMatrix__SWIG_12(rowmap, numentriesperrowtoalloc) & type(SwigArrayWrapper) :: farg2 farg1 = rowmap%swigdata +if (size(numentriesperrowtoalloc) > 0) then farg2_view => numentriesperrowtoalloc(1) farg2%data = c_loc(farg2_view) farg2%size = size(numentriesperrowtoalloc) +else +farg2%data = c_null_ptr +farg2%size = 0 +end if fresult = swigc_new_TpetraCrsMatrix__SWIG_12(farg1, farg2) self%swigdata = fresult end function @@ -10494,9 +10795,14 @@ function new_TpetraCrsMatrix__SWIG_13(rowmap, colmap, numentriesperrowtoalloc, p farg1 = rowmap%swigdata farg2 = colmap%swigdata +if (size(numentriesperrowtoalloc) > 0) then farg3_view => numentriesperrowtoalloc(1) farg3%data = c_loc(farg3_view) farg3%size = size(numentriesperrowtoalloc) +else +farg3%data = c_null_ptr +farg3%size = 0 +end if farg4 = pftype farg5 = params%swigdata fresult = swigc_new_TpetraCrsMatrix__SWIG_13(farg1, farg2, farg3, farg4, farg5) @@ -10523,9 +10829,14 @@ function new_TpetraCrsMatrix__SWIG_14(rowmap, colmap, numentriesperrowtoalloc, p farg1 = rowmap%swigdata farg2 = colmap%swigdata +if (size(numentriesperrowtoalloc) > 0) then farg3_view => numentriesperrowtoalloc(1) farg3%data = c_loc(farg3_view) farg3%size = size(numentriesperrowtoalloc) +else +farg3%data = c_null_ptr +farg3%size = 0 +end if farg4 = pftype fresult = swigc_new_TpetraCrsMatrix__SWIG_14(farg1, farg2, farg3, farg4) self%swigdata = fresult @@ -10549,9 +10860,14 @@ function new_TpetraCrsMatrix__SWIG_15(rowmap, colmap, numentriesperrowtoalloc) & farg1 = rowmap%swigdata farg2 = colmap%swigdata +if (size(numentriesperrowtoalloc) > 0) then farg3_view => numentriesperrowtoalloc(1) farg3%data = c_loc(farg3_view) farg3%size = size(numentriesperrowtoalloc) +else +farg3%data = c_null_ptr +farg3%size = 0 +end if fresult = swigc_new_TpetraCrsMatrix__SWIG_15(farg1, farg2, farg3) self%swigdata = fresult end function @@ -10582,15 +10898,30 @@ function new_TpetraCrsMatrix__SWIG_16(rowmap, colmap, rowpointers, columnindices farg1 = rowmap%swigdata farg2 = colmap%swigdata +if (size(rowpointers) > 0) then farg3_view => rowpointers(1) farg3%data = c_loc(farg3_view) farg3%size = size(rowpointers) +else +farg3%data = c_null_ptr +farg3%size = 0 +end if +if (size(columnindices) > 0) then farg4_view => columnindices(1) farg4%data = c_loc(farg4_view) farg4%size = size(columnindices) +else +farg4%data = c_null_ptr +farg4%size = 0 +end if +if (size(values) > 0) then farg5_view => values(1) farg5%data = c_loc(farg5_view) farg5%size = size(values) +else +farg5%data = c_null_ptr +farg5%size = 0 +end if farg6 = params%swigdata fresult = swigc_new_TpetraCrsMatrix__SWIG_16(farg1, farg2, farg3, farg4, farg5, farg6) self%swigdata = fresult @@ -10620,15 +10951,30 @@ function new_TpetraCrsMatrix__SWIG_17(rowmap, colmap, rowpointers, columnindices farg1 = rowmap%swigdata farg2 = colmap%swigdata +if (size(rowpointers) > 0) then farg3_view => rowpointers(1) farg3%data = c_loc(farg3_view) farg3%size = size(rowpointers) +else +farg3%data = c_null_ptr +farg3%size = 0 +end if +if (size(columnindices) > 0) then farg4_view => columnindices(1) farg4%data = c_loc(farg4_view) farg4%size = size(columnindices) +else +farg4%data = c_null_ptr +farg4%size = 0 +end if +if (size(values) > 0) then farg5_view => values(1) farg5%data = c_loc(farg5_view) farg5%size = size(values) +else +farg5%data = c_null_ptr +farg5%size = 0 +end if fresult = swigc_new_TpetraCrsMatrix__SWIG_17(farg1, farg2, farg3, farg4, farg5) self%swigdata = fresult end function @@ -10650,15 +10996,30 @@ subroutine swigf_TpetraCrsMatrix_setAllValues(self, ptr, ind, val) type(SwigArrayWrapper) :: farg4 farg1 = self%swigdata +if (size(ptr) > 0) then farg2_view => ptr(1) farg2%data = c_loc(farg2_view) farg2%size = size(ptr) +else +farg2%data = c_null_ptr +farg2%size = 0 +end if +if (size(ind) > 0) then farg3_view => ind(1) farg3%data = c_loc(farg3_view) farg3%size = size(ind) +else +farg3%data = c_null_ptr +farg3%size = 0 +end if +if (size(val) > 0) then farg4_view => val(1) farg4%data = c_loc(farg4_view) farg4%size = size(val) +else +farg4%data = c_null_ptr +farg4%size = 0 +end if call swigc_TpetraCrsMatrix_setAllValues(farg1, farg2, farg3, farg4) end subroutine @@ -10679,15 +11040,30 @@ subroutine swigf_TpetraCrsMatrix_getAllValues(self, rowpointers, columnindices, type(SwigArrayWrapper) :: farg4 farg1 = self%swigdata +if (size(rowpointers) > 0) then farg2_view => rowpointers(1) farg2%data = c_loc(farg2_view) farg2%size = size(rowpointers) +else +farg2%data = c_null_ptr +farg2%size = 0 +end if +if (size(columnindices) > 0) then farg3_view => columnindices(1) farg3%data = c_loc(farg3_view) farg3%size = size(columnindices) +else +farg3%data = c_null_ptr +farg3%size = 0 +end if +if (size(values) > 0) then farg4_view => values(1) farg4%data = c_loc(farg4_view) farg4%size = size(values) +else +farg4%data = c_null_ptr +farg4%size = 0 +end if call swigc_TpetraCrsMatrix_getAllValues(farg1, farg2, farg3, farg4) end subroutine diff --git a/src/tpetra/src/swig/fortpetraFORTRAN_wrap.cxx b/src/tpetra/src/swig/fortpetraFORTRAN_wrap.cxx index 5af86baa..4de9f707 100644 --- a/src/tpetra/src/swig/fortpetraFORTRAN_wrap.cxx +++ b/src/tpetra/src/swig/fortpetraFORTRAN_wrap.cxx @@ -1131,7 +1131,7 @@ SWIGEXPORT SwigClassWrapper _wrap_new_TpetraMap__SWIG_5(long const *farg1, SwigA long long arg3 ; Teuchos::RCP< Teuchos::Comm< int > const > *arg4 = 0 ; Teuchos::RCP< Kokkos::Compat::KokkosSerialWrapperNode > *arg5 = 0 ; - Teuchos::ArrayView< long long const > tmparr2 ; + Teuchos::ArrayView< long long const > tmpview2 ; Teuchos::RCP< Teuchos::Comm< int > const > tempnull4 ; Tpetra::Map< LO,GO,NO > *result = 0 ; @@ -1139,8 +1139,8 @@ SWIGEXPORT SwigClassWrapper _wrap_new_TpetraMap__SWIG_5(long const *farg1, SwigA arg3 = 1; } arg1 = static_cast< Tpetra::global_size_t >(*farg1); - tmparr2 = Teuchos::ArrayView(static_cast(farg2->data), farg2->size); - arg2 = &tmparr2; + tmpview2 = Teuchos::ArrayView(static_cast(farg2->data), farg2->size); + arg2 = &tmpview2; arg4 = farg4->cptr ? static_cast< Teuchos::RCP< Teuchos::Comm< int > const > * >(farg4->cptr) : &tempnull4; SWIG_check_nonnull(*farg5, "Teuchos::RCP< Kokkos::Compat::KokkosSerialWrapperNode > const &", "SWIGTYPE_Teuchos__RCPT_Kokkos__Compat__KokkosSerialWrapper9ZCDM", "Tpetra::Map< LO,GO,NO >::Map(Tpetra::global_size_t const,Teuchos::ArrayView< long long const > const &,long long const,Teuchos::RCP< Teuchos::Comm< int > const > const &,Teuchos::RCP< Kokkos::Compat::KokkosSerialWrapperNode > const &)", return SwigClassWrapper_uninitialized()); arg5 = static_cast< Teuchos::RCP< Kokkos::Compat::KokkosSerialWrapperNode > * >(farg5->cptr); @@ -1179,7 +1179,7 @@ SWIGEXPORT SwigClassWrapper _wrap_new_TpetraMap__SWIG_6(long const *farg1, SwigA Teuchos::ArrayView< long long const > *arg2 = 0 ; long long arg3 ; Teuchos::RCP< Teuchos::Comm< int > const > *arg4 = 0 ; - Teuchos::ArrayView< long long const > tmparr2 ; + Teuchos::ArrayView< long long const > tmpview2 ; Teuchos::RCP< Teuchos::Comm< int > const > tempnull4 ; Tpetra::Map< LO,GO,NO > *result = 0 ; @@ -1187,8 +1187,8 @@ SWIGEXPORT SwigClassWrapper _wrap_new_TpetraMap__SWIG_6(long const *farg1, SwigA arg3 = 1; } arg1 = static_cast< Tpetra::global_size_t >(*farg1); - tmparr2 = Teuchos::ArrayView(static_cast(farg2->data), farg2->size); - arg2 = &tmparr2; + tmpview2 = Teuchos::ArrayView(static_cast(farg2->data), farg2->size); + arg2 = &tmpview2; arg4 = farg4->cptr ? static_cast< Teuchos::RCP< Teuchos::Comm< int > const > * >(farg4->cptr) : &tempnull4; { // Make sure no unhandled exceptions exist before performing a new action @@ -1692,19 +1692,19 @@ SWIGEXPORT int _wrap_TpetraMap_getRemoteIndexList__SWIG_0(SwigClassWrapper const Teuchos::ArrayView< int > *arg3 = 0 ; Teuchos::ArrayView< int > *arg4 = 0 ; Teuchos::RCP< Tpetra::Map< LO,GO,NO > const > *smartarg1 ; - Teuchos::ArrayView< long long const > tmparr2 ; - Teuchos::ArrayView< int > tmparr3 ; - Teuchos::ArrayView< int > tmparr4 ; + Teuchos::ArrayView< long long const > tmpview2 ; + Teuchos::ArrayView< int > tmpview3 ; + Teuchos::ArrayView< int > tmpview4 ; Tpetra::LookupStatus result; smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); arg1 = smartarg1 ? const_cast< Tpetra::Map* >(smartarg1->get()) : NULL; - tmparr2 = Teuchos::ArrayView(static_cast(farg2->data), farg2->size); - arg2 = &tmparr2; - tmparr3 = Teuchos::ArrayView(static_cast(farg3->data), farg3->size); - arg3 = &tmparr3; - tmparr4 = Teuchos::ArrayView(static_cast(farg4->data), farg4->size); - arg4 = &tmparr4; + tmpview2 = Teuchos::ArrayView(static_cast(farg2->data), farg2->size); + arg2 = &tmpview2; + tmpview3 = Teuchos::ArrayView(static_cast(farg3->data), farg3->size); + arg3 = &tmpview3; + tmpview4 = Teuchos::ArrayView(static_cast(farg4->data), farg4->size); + arg4 = &tmpview4; { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::Map< LO,GO,NO >::getRemoteIndexList(Teuchos::ArrayView< long long const > const &,Teuchos::ArrayView< int > const &,Teuchos::ArrayView< int > const &) const");; @@ -1729,10 +1729,10 @@ SWIGEXPORT int _wrap_TpetraMap_getRemoteIndexList__SWIG_0(SwigClassWrapper const } } fresult = static_cast< int >(result); - for (int i = 0; i < tmparr3.size(); i++) - tmparr3[i] += 1; - for (int i = 0; i < tmparr4.size(); i++) - tmparr4[i] += 1; + for (int i = 0; i < tmpview3.size(); i++) + tmpview3[i] += 1; + for (int i = 0; i < tmpview4.size(); i++) + tmpview4[i] += 1; return fresult; } @@ -1743,16 +1743,16 @@ SWIGEXPORT int _wrap_TpetraMap_getRemoteIndexList__SWIG_1(SwigClassWrapper const Teuchos::ArrayView< long long const > *arg2 = 0 ; Teuchos::ArrayView< int > *arg3 = 0 ; Teuchos::RCP< Tpetra::Map< LO,GO,NO > const > *smartarg1 ; - Teuchos::ArrayView< long long const > tmparr2 ; - Teuchos::ArrayView< int > tmparr3 ; + Teuchos::ArrayView< long long const > tmpview2 ; + Teuchos::ArrayView< int > tmpview3 ; Tpetra::LookupStatus result; smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); arg1 = smartarg1 ? const_cast< Tpetra::Map* >(smartarg1->get()) : NULL; - tmparr2 = Teuchos::ArrayView(static_cast(farg2->data), farg2->size); - arg2 = &tmparr2; - tmparr3 = Teuchos::ArrayView(static_cast(farg3->data), farg3->size); - arg3 = &tmparr3; + tmpview2 = Teuchos::ArrayView(static_cast(farg2->data), farg2->size); + arg2 = &tmpview2; + tmpview3 = Teuchos::ArrayView(static_cast(farg3->data), farg3->size); + arg3 = &tmpview3; { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::Map< LO,GO,NO >::getRemoteIndexList(Teuchos::ArrayView< long long const > const &,Teuchos::ArrayView< int > const &) const");; @@ -1777,8 +1777,8 @@ SWIGEXPORT int _wrap_TpetraMap_getRemoteIndexList__SWIG_1(SwigClassWrapper const } } fresult = static_cast< int >(result); - for (int i = 0; i < tmparr3.size(); i++) - tmparr3[i] += 1; + for (int i = 0; i < tmpview3.size(); i++) + tmpview3[i] += 1; return fresult; } @@ -3695,12 +3695,12 @@ SWIGEXPORT SwigClassWrapper _wrap_new_TpetraMultiVector__SWIG_5(SwigClassWrapper size_t arg3 ; size_t arg4 ; Teuchos::RCP< Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > tempnull1 ; - Teuchos::ArrayView< double const > tmparr2 ; + Teuchos::ArrayView< double const > tmpview2 ; Tpetra::MultiVector< SC,LO,GO,NO > *result = 0 ; arg1 = farg1->cptr ? static_cast< Teuchos::RCP< Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg1->cptr) : &tempnull1; - tmparr2 = Teuchos::ArrayView(static_cast(farg2->data), farg2->size); - arg2 = &tmparr2; + tmpview2 = Teuchos::ArrayView(static_cast(farg2->data), farg2->size); + arg2 = &tmpview2; arg3 = static_cast< size_t >(*farg3); arg4 = static_cast< size_t >(*farg4); { @@ -4629,12 +4629,12 @@ SWIGEXPORT void _wrap_TpetraMultiVector_get1dCopy(SwigClassWrapper const *farg1, Teuchos::ArrayView< double > *arg2 = 0 ; size_t arg3 ; Teuchos::RCP< Tpetra::MultiVector< SC,LO,GO,NO > const > *smartarg1 ; - Teuchos::ArrayView< double > tmparr2 ; + Teuchos::ArrayView< double > tmpview2 ; smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); arg1 = smartarg1 ? const_cast< Tpetra::MultiVector* >(smartarg1->get()) : NULL; - tmparr2 = Teuchos::ArrayView(static_cast(farg2->data), farg2->size); - arg2 = &tmparr2; + tmpview2 = Teuchos::ArrayView(static_cast(farg2->data), farg2->size); + arg2 = &tmpview2; arg3 = static_cast< size_t >(*farg3); { // Make sure no unhandled exceptions exist before performing a new action @@ -4947,15 +4947,15 @@ SWIGEXPORT void _wrap_TpetraMultiVector_dot__SWIG_0(SwigClassWrapper const *farg Teuchos::ArrayView< Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::dot_type > *arg3 = 0 ; Teuchos::RCP< Tpetra::MultiVector< SC,LO,GO,NO > const > *smartarg1 ; Teuchos::RCP< Tpetra::MultiVector< SC,LO,GO,NO > const > *smartarg2 ; - Teuchos::ArrayView< double > tmparr3 ; + Teuchos::ArrayView< double > tmpview3 ; smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); arg1 = smartarg1 ? const_cast< Tpetra::MultiVector* >(smartarg1->get()) : NULL; SWIG_check_sp_nonnull(farg2, "Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > *", "TpetraMultiVector", "Tpetra::MultiVector< SC,LO,GO,NO >::dot(Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &,Teuchos::ArrayView< Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::dot_type > const &) const", return ) smartarg2 = static_cast< Teuchos::RCP >* >(farg2->cptr); arg2 = const_cast< Tpetra::MultiVector* >(smartarg2->get()); - tmparr3 = Teuchos::ArrayView(static_cast(farg3->data), farg3->size); - arg3 = &tmparr3; + tmpview3 = Teuchos::ArrayView(static_cast(farg3->data), farg3->size); + arg3 = &tmpview3; { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::dot(Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &,Teuchos::ArrayView< Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::dot_type > const &) const");; @@ -5141,12 +5141,12 @@ SWIGEXPORT void _wrap_TpetraMultiVector_scale__SWIG_1(SwigClassWrapper const *fa Tpetra::MultiVector< SC,LO,GO,NO > *arg1 = (Tpetra::MultiVector< SC,LO,GO,NO > *) 0 ; Teuchos::ArrayView< double const > *arg2 = 0 ; Teuchos::RCP< Tpetra::MultiVector< SC,LO,GO,NO > > *smartarg1 ; - Teuchos::ArrayView< double const > tmparr2 ; + Teuchos::ArrayView< double const > tmpview2 ; smartarg1 = static_cast< Teuchos::RCP< Tpetra::MultiVector >* >(farg1->cptr); arg1 = smartarg1 ? const_cast< Tpetra::MultiVector* >(smartarg1->get()) : NULL; - tmparr2 = Teuchos::ArrayView(static_cast(farg2->data), farg2->size); - arg2 = &tmparr2; + tmpview2 = Teuchos::ArrayView(static_cast(farg2->data), farg2->size); + arg2 = &tmpview2; { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::scale(Teuchos::ArrayView< double const > const &)");; @@ -5357,12 +5357,12 @@ SWIGEXPORT void _wrap_TpetraMultiVector_norm1__SWIG_3(SwigClassWrapper const *fa Tpetra::MultiVector< SC,LO,GO,NO > *arg1 = (Tpetra::MultiVector< SC,LO,GO,NO > *) 0 ; Teuchos::ArrayView< Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::mag_type > *arg2 = 0 ; Teuchos::RCP< Tpetra::MultiVector< SC,LO,GO,NO > const > *smartarg1 ; - Teuchos::ArrayView< double > tmparr2 ; + Teuchos::ArrayView< double > tmpview2 ; smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); arg1 = smartarg1 ? const_cast< Tpetra::MultiVector* >(smartarg1->get()) : NULL; - tmparr2 = Teuchos::ArrayView(static_cast(farg2->data), farg2->size); - arg2 = &tmparr2; + tmpview2 = Teuchos::ArrayView(static_cast(farg2->data), farg2->size); + arg2 = &tmpview2; { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::norm1(Teuchos::ArrayView< Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::mag_type > const &) const");; @@ -5430,12 +5430,12 @@ SWIGEXPORT void _wrap_TpetraMultiVector_norm2__SWIG_3(SwigClassWrapper const *fa Tpetra::MultiVector< SC,LO,GO,NO > *arg1 = (Tpetra::MultiVector< SC,LO,GO,NO > *) 0 ; Teuchos::ArrayView< Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::mag_type > *arg2 = 0 ; Teuchos::RCP< Tpetra::MultiVector< SC,LO,GO,NO > const > *smartarg1 ; - Teuchos::ArrayView< double > tmparr2 ; + Teuchos::ArrayView< double > tmpview2 ; smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); arg1 = smartarg1 ? const_cast< Tpetra::MultiVector* >(smartarg1->get()) : NULL; - tmparr2 = Teuchos::ArrayView(static_cast(farg2->data), farg2->size); - arg2 = &tmparr2; + tmpview2 = Teuchos::ArrayView(static_cast(farg2->data), farg2->size); + arg2 = &tmpview2; { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::norm2(Teuchos::ArrayView< Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::mag_type > const &) const");; @@ -5503,12 +5503,12 @@ SWIGEXPORT void _wrap_TpetraMultiVector_normInf__SWIG_3(SwigClassWrapper const * Tpetra::MultiVector< SC,LO,GO,NO > *arg1 = (Tpetra::MultiVector< SC,LO,GO,NO > *) 0 ; Teuchos::ArrayView< Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::mag_type > *arg2 = 0 ; Teuchos::RCP< Tpetra::MultiVector< SC,LO,GO,NO > const > *smartarg1 ; - Teuchos::ArrayView< double > tmparr2 ; + Teuchos::ArrayView< double > tmpview2 ; smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); arg1 = smartarg1 ? const_cast< Tpetra::MultiVector* >(smartarg1->get()) : NULL; - tmparr2 = Teuchos::ArrayView(static_cast(farg2->data), farg2->size); - arg2 = &tmparr2; + tmpview2 = Teuchos::ArrayView(static_cast(farg2->data), farg2->size); + arg2 = &tmpview2; { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::normInf(Teuchos::ArrayView< Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::mag_type > const &) const");; @@ -5540,12 +5540,12 @@ SWIGEXPORT void _wrap_TpetraMultiVector_meanValue(SwigClassWrapper const *farg1, Tpetra::MultiVector< SC,LO,GO,NO > *arg1 = (Tpetra::MultiVector< SC,LO,GO,NO > *) 0 ; Teuchos::ArrayView< Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::impl_scalar_type > *arg2 = 0 ; Teuchos::RCP< Tpetra::MultiVector< SC,LO,GO,NO > const > *smartarg1 ; - Teuchos::ArrayView< double > tmparr2 ; + Teuchos::ArrayView< double > tmpview2 ; smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); arg1 = smartarg1 ? const_cast< Tpetra::MultiVector* >(smartarg1->get()) : NULL; - tmparr2 = Teuchos::ArrayView(static_cast(farg2->data), farg2->size); - arg2 = &tmparr2; + tmpview2 = Teuchos::ArrayView(static_cast(farg2->data), farg2->size); + arg2 = &tmpview2; { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::meanValue(Teuchos::ArrayView< Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::impl_scalar_type > const &) const");; @@ -7109,13 +7109,13 @@ SWIGEXPORT void _wrap_TpetraCrsGraph_insertGlobalIndices__SWIG_0(SwigClassWrappe long long arg2 ; Teuchos::ArrayView< long long const > *arg3 = 0 ; Teuchos::RCP< Tpetra::CrsGraph< LO,GO,NO > > *smartarg1 ; - Teuchos::ArrayView< long long const > tmparr3 ; + Teuchos::ArrayView< long long const > tmpview3 ; smartarg1 = static_cast< Teuchos::RCP< Tpetra::CrsGraph >* >(farg1->cptr); arg1 = smartarg1 ? const_cast< Tpetra::CrsGraph* >(smartarg1->get()) : NULL; arg2 = static_cast< long long >(*farg2); - tmparr3 = Teuchos::ArrayView(static_cast(farg3->data), farg3->size); - arg3 = &tmparr3; + tmpview3 = Teuchos::ArrayView(static_cast(farg3->data), farg3->size); + arg3 = &tmpview3; { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::insertGlobalIndices(long long const,Teuchos::ArrayView< long long const > const &)");; @@ -8717,13 +8717,13 @@ SWIGEXPORT void _wrap_TpetraCrsGraph_getGlobalRowCopy(SwigClassWrapper const *fa Teuchos::ArrayView< long long > *arg3 = 0 ; size_t *arg4 = 0 ; Teuchos::RCP< Tpetra::CrsGraph< LO,GO,NO > const > *smartarg1 ; - Teuchos::ArrayView< long long > tmparr3 ; + Teuchos::ArrayView< long long > tmpview3 ; smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); arg1 = smartarg1 ? const_cast< Tpetra::CrsGraph* >(smartarg1->get()) : NULL; arg2 = static_cast< long long >(*farg2); - tmparr3 = Teuchos::ArrayView(static_cast(farg3->data), farg3->size); - arg3 = &tmparr3; + tmpview3 = Teuchos::ArrayView(static_cast(farg3->data), farg3->size); + arg3 = &tmpview3; arg4 = reinterpret_cast< size_t * >(farg4); { // Make sure no unhandled exceptions exist before performing a new action @@ -8758,13 +8758,13 @@ SWIGEXPORT void _wrap_TpetraCrsGraph_getLocalRowCopy(SwigClassWrapper const *far Teuchos::ArrayView< int > *arg3 = 0 ; size_t *arg4 = 0 ; Teuchos::RCP< Tpetra::CrsGraph< LO,GO,NO > const > *smartarg1 ; - Teuchos::ArrayView< int > tmparr3 ; + Teuchos::ArrayView< int > tmpview3 ; smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); arg1 = smartarg1 ? const_cast< Tpetra::CrsGraph* >(smartarg1->get()) : NULL; arg2 = *farg2 - 1; - tmparr3 = Teuchos::ArrayView(static_cast(farg3->data), farg3->size); - arg3 = &tmparr3; + tmpview3 = Teuchos::ArrayView(static_cast(farg3->data), farg3->size); + arg3 = &tmpview3; arg4 = reinterpret_cast< size_t * >(farg4); { // Make sure no unhandled exceptions exist before performing a new action @@ -8790,8 +8790,8 @@ SWIGEXPORT void _wrap_TpetraCrsGraph_getLocalRowCopy(SwigClassWrapper const *far } } - for (int i = 0; i < tmparr3.size(); i++) - tmparr3[i] += 1; + for (int i = 0; i < tmpview3.size(); i++) + tmpview3[i] += 1; } @@ -10604,16 +10604,16 @@ SWIGEXPORT void _wrap_TpetraCrsMatrix_insertGlobalValues(SwigClassWrapper const Teuchos::ArrayView< long long const > *arg3 = 0 ; Teuchos::ArrayView< double const > *arg4 = 0 ; Teuchos::RCP< Tpetra::CrsMatrix< SC,LO,GO,NO > > *smartarg1 ; - Teuchos::ArrayView< long long const > tmparr3 ; - Teuchos::ArrayView< double const > tmparr4 ; + Teuchos::ArrayView< long long const > tmpview3 ; + Teuchos::ArrayView< double const > tmpview4 ; smartarg1 = static_cast< Teuchos::RCP< Tpetra::CrsMatrix >* >(farg1->cptr); arg1 = smartarg1 ? const_cast< Tpetra::CrsMatrix* >(smartarg1->get()) : NULL; arg2 = static_cast< long long >(*farg2); - tmparr3 = Teuchos::ArrayView(static_cast(farg3->data), farg3->size); - arg3 = &tmparr3; - tmparr4 = Teuchos::ArrayView(static_cast(farg4->data), farg4->size); - arg4 = &tmparr4; + tmpview3 = Teuchos::ArrayView(static_cast(farg3->data), farg3->size); + arg3 = &tmpview3; + tmpview4 = Teuchos::ArrayView(static_cast(farg4->data), farg4->size); + arg4 = &tmpview4; { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::insertGlobalValues(long long const,Teuchos::ArrayView< long long const > const &,Teuchos::ArrayView< double const > const &)");; @@ -10650,7 +10650,7 @@ SWIGEXPORT void _wrap_TpetraCrsMatrix_insertLocalValues(SwigClassWrapper const * Teuchos::ArrayView< int const >::value_type *tmpbegin3 ; Teuchos::Array< std::remove_const< Teuchos::ArrayView< int const >::value_type >::type > tmparr3 ; Teuchos::ArrayView< int const > tmpview3 ; - Teuchos::ArrayView< double const > tmparr4 ; + Teuchos::ArrayView< double const > tmpview4 ; smartarg1 = static_cast< Teuchos::RCP< Tpetra::CrsMatrix >* >(farg1->cptr); arg1 = smartarg1 ? const_cast< Tpetra::CrsMatrix* >(smartarg1->get()) : NULL; @@ -10661,8 +10661,8 @@ SWIGEXPORT void _wrap_TpetraCrsMatrix_insertLocalValues(SwigClassWrapper const * tmparr3[i] = tmpbegin3[i] - 1; tmpview3 = tmparr3(); arg3 = &tmpview3; - tmparr4 = Teuchos::ArrayView(static_cast(farg4->data), farg4->size); - arg4 = &tmparr4; + tmpview4 = Teuchos::ArrayView(static_cast(farg4->data), farg4->size); + arg4 = &tmpview4; { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::insertLocalValues(int const,Teuchos::ArrayView< int const > const &,Teuchos::ArrayView< double const > const &)");; @@ -10697,17 +10697,17 @@ SWIGEXPORT int _wrap_TpetraCrsMatrix_replaceGlobalValues(SwigClassWrapper const Teuchos::ArrayView< long long const > *arg3 = 0 ; Teuchos::ArrayView< double const > *arg4 = 0 ; Teuchos::RCP< Tpetra::CrsMatrix< SC,LO,GO,NO > const > *smartarg1 ; - Teuchos::ArrayView< long long const > tmparr3 ; - Teuchos::ArrayView< double const > tmparr4 ; + Teuchos::ArrayView< long long const > tmpview3 ; + Teuchos::ArrayView< double const > tmpview4 ; int result; smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); arg1 = smartarg1 ? const_cast< Tpetra::CrsMatrix* >(smartarg1->get()) : NULL; arg2 = static_cast< long long >(*farg2); - tmparr3 = Teuchos::ArrayView(static_cast(farg3->data), farg3->size); - arg3 = &tmparr3; - tmparr4 = Teuchos::ArrayView(static_cast(farg4->data), farg4->size); - arg4 = &tmparr4; + tmpview3 = Teuchos::ArrayView(static_cast(farg3->data), farg3->size); + arg3 = &tmpview3; + tmpview4 = Teuchos::ArrayView(static_cast(farg4->data), farg4->size); + arg4 = &tmpview4; { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::replaceGlobalValues(long long const,Teuchos::ArrayView< long long const > const &,Teuchos::ArrayView< double const > const &) const");; @@ -10746,7 +10746,7 @@ SWIGEXPORT int _wrap_TpetraCrsMatrix_replaceLocalValues__SWIG_1(SwigClassWrapper Teuchos::ArrayView< int const >::value_type *tmpbegin3 ; Teuchos::Array< std::remove_const< Teuchos::ArrayView< int const >::value_type >::type > tmparr3 ; Teuchos::ArrayView< int const > tmpview3 ; - Teuchos::ArrayView< double const > tmparr4 ; + Teuchos::ArrayView< double const > tmpview4 ; int result; smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); @@ -10758,8 +10758,8 @@ SWIGEXPORT int _wrap_TpetraCrsMatrix_replaceLocalValues__SWIG_1(SwigClassWrapper tmparr3[i] = tmpbegin3[i] - 1; tmpview3 = tmparr3(); arg3 = &tmpview3; - tmparr4 = Teuchos::ArrayView(static_cast(farg4->data), farg4->size); - arg4 = &tmparr4; + tmpview4 = Teuchos::ArrayView(static_cast(farg4->data), farg4->size); + arg4 = &tmpview4; { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::replaceLocalValues(int const,Teuchos::ArrayView< int const > const &,Teuchos::ArrayView< double const > const &) const");; @@ -10840,8 +10840,8 @@ SWIGEXPORT int _wrap_TpetraCrsMatrix_sumIntoGlobalValues__SWIG_0(SwigClassWrappe Teuchos::ArrayView< double const > *arg4 = 0 ; bool arg5 ; Teuchos::RCP< Tpetra::CrsMatrix< SC,LO,GO,NO > > *smartarg1 ; - Teuchos::ArrayView< long long const > tmparr3 ; - Teuchos::ArrayView< double const > tmparr4 ; + Teuchos::ArrayView< long long const > tmpview3 ; + Teuchos::ArrayView< double const > tmpview4 ; int result; { @@ -10850,10 +10850,10 @@ SWIGEXPORT int _wrap_TpetraCrsMatrix_sumIntoGlobalValues__SWIG_0(SwigClassWrappe smartarg1 = static_cast< Teuchos::RCP< Tpetra::CrsMatrix >* >(farg1->cptr); arg1 = smartarg1 ? const_cast< Tpetra::CrsMatrix* >(smartarg1->get()) : NULL; arg2 = static_cast< long long >(*farg2); - tmparr3 = Teuchos::ArrayView(static_cast(farg3->data), farg3->size); - arg3 = &tmparr3; - tmparr4 = Teuchos::ArrayView(static_cast(farg4->data), farg4->size); - arg4 = &tmparr4; + tmpview3 = Teuchos::ArrayView(static_cast(farg3->data), farg3->size); + arg3 = &tmpview3; + tmpview4 = Teuchos::ArrayView(static_cast(farg4->data), farg4->size); + arg4 = &tmpview4; { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::sumIntoGlobalValues(long long const,Teuchos::ArrayView< long long const > const &,Teuchos::ArrayView< double const > const &,bool const)");; @@ -10893,7 +10893,7 @@ SWIGEXPORT int _wrap_TpetraCrsMatrix_sumIntoLocalValues__SWIG_0(SwigClassWrapper Teuchos::ArrayView< int const >::value_type *tmpbegin3 ; Teuchos::Array< std::remove_const< Teuchos::ArrayView< int const >::value_type >::type > tmparr3 ; Teuchos::ArrayView< int const > tmpview3 ; - Teuchos::ArrayView< double const > tmparr4 ; + Teuchos::ArrayView< double const > tmpview4 ; int result; { @@ -10908,8 +10908,8 @@ SWIGEXPORT int _wrap_TpetraCrsMatrix_sumIntoLocalValues__SWIG_0(SwigClassWrapper tmparr3[i] = tmpbegin3[i] - 1; tmpview3 = tmparr3(); arg3 = &tmpview3; - tmparr4 = Teuchos::ArrayView(static_cast(farg4->data), farg4->size); - arg4 = &tmparr4; + tmpview4 = Teuchos::ArrayView(static_cast(farg4->data), farg4->size); + arg4 = &tmpview4; { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::sumIntoLocalValues(int const,Teuchos::ArrayView< int const > const &,Teuchos::ArrayView< double const > const &,bool const) const");; @@ -12556,16 +12556,16 @@ SWIGEXPORT void _wrap_TpetraCrsMatrix_getGlobalRowCopy(SwigClassWrapper const *f Teuchos::ArrayView< double > *arg4 = 0 ; size_t *arg5 = 0 ; Teuchos::RCP< Tpetra::CrsMatrix< SC,LO,GO,NO > const > *smartarg1 ; - Teuchos::ArrayView< long long > tmparr3 ; - Teuchos::ArrayView< double > tmparr4 ; + Teuchos::ArrayView< long long > tmpview3 ; + Teuchos::ArrayView< double > tmpview4 ; smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); arg1 = smartarg1 ? const_cast< Tpetra::CrsMatrix* >(smartarg1->get()) : NULL; arg2 = static_cast< long long >(*farg2); - tmparr3 = Teuchos::ArrayView(static_cast(farg3->data), farg3->size); - arg3 = &tmparr3; - tmparr4 = Teuchos::ArrayView(static_cast(farg4->data), farg4->size); - arg4 = &tmparr4; + tmpview3 = Teuchos::ArrayView(static_cast(farg3->data), farg3->size); + arg3 = &tmpview3; + tmpview4 = Teuchos::ArrayView(static_cast(farg4->data), farg4->size); + arg4 = &tmpview4; arg5 = reinterpret_cast< size_t * >(farg5); { // Make sure no unhandled exceptions exist before performing a new action @@ -12601,16 +12601,16 @@ SWIGEXPORT void _wrap_TpetraCrsMatrix_getLocalRowCopy(SwigClassWrapper const *fa Teuchos::ArrayView< double > *arg4 = 0 ; size_t *arg5 = 0 ; Teuchos::RCP< Tpetra::CrsMatrix< SC,LO,GO,NO > const > *smartarg1 ; - Teuchos::ArrayView< int > tmparr3 ; - Teuchos::ArrayView< double > tmparr4 ; + Teuchos::ArrayView< int > tmpview3 ; + Teuchos::ArrayView< double > tmpview4 ; smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); arg1 = smartarg1 ? const_cast< Tpetra::CrsMatrix* >(smartarg1->get()) : NULL; arg2 = *farg2 - 1; - tmparr3 = Teuchos::ArrayView(static_cast(farg3->data), farg3->size); - arg3 = &tmparr3; - tmparr4 = Teuchos::ArrayView(static_cast(farg4->data), farg4->size); - arg4 = &tmparr4; + tmpview3 = Teuchos::ArrayView(static_cast(farg3->data), farg3->size); + arg3 = &tmpview3; + tmpview4 = Teuchos::ArrayView(static_cast(farg4->data), farg4->size); + arg4 = &tmpview4; arg5 = reinterpret_cast< size_t * >(farg5); { // Make sure no unhandled exceptions exist before performing a new action @@ -12636,25 +12636,27 @@ SWIGEXPORT void _wrap_TpetraCrsMatrix_getLocalRowCopy(SwigClassWrapper const *fa } } - for (int i = 0; i < tmparr3.size(); i++) - tmparr3[i] += 1; + for (int i = 0; i < tmpview3.size(); i++) + tmpview3[i] += 1; } -SWIGEXPORT void _wrap_TpetraCrsMatrix_getGlobalRowView(SwigClassWrapper const *farg1, long long const *farg2, SwigClassWrapper const *farg3, SwigClassWrapper const *farg4) { +SWIGEXPORT void _wrap_TpetraCrsMatrix_getGlobalRowView(SwigClassWrapper const *farg1, long long const *farg2, SwigArrayWrapper *farg3, SwigArrayWrapper *farg4) { Tpetra::CrsMatrix< SC,LO,GO,NO > *arg1 = (Tpetra::CrsMatrix< SC,LO,GO,NO > *) 0 ; long long arg2 ; Teuchos::ArrayView< long long const > *arg3 = 0 ; Teuchos::ArrayView< double const > *arg4 = 0 ; Teuchos::RCP< Tpetra::CrsMatrix< SC,LO,GO,NO > const > *smartarg1 ; + Teuchos::ArrayView< long long const > tmpview3 ; + Teuchos::ArrayView< double const > tmpview4 ; smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); arg1 = smartarg1 ? const_cast< Tpetra::CrsMatrix* >(smartarg1->get()) : NULL; arg2 = static_cast< long long >(*farg2); - SWIG_check_mutable_nonnull(*farg3, "Teuchos::ArrayView< long long const > &", "SWIGTYPE_Teuchos__ArrayViewT_long_long_const_t", "Tpetra::CrsMatrix< SC,LO,GO,NO >::getGlobalRowView(long long,Teuchos::ArrayView< long long const > &,Teuchos::ArrayView< double const > &) const", return ); - arg3 = static_cast< Teuchos::ArrayView< long long const > * >(farg3->cptr); - SWIG_check_mutable_nonnull(*farg4, "Teuchos::ArrayView< double const > &", "SWIGTYPE_Teuchos__ArrayViewT_double_const_t", "Tpetra::CrsMatrix< SC,LO,GO,NO >::getGlobalRowView(long long,Teuchos::ArrayView< long long const > &,Teuchos::ArrayView< double const > &) const", return ); - arg4 = static_cast< Teuchos::ArrayView< double const > * >(farg4->cptr); + tmpview3 = Teuchos::ArrayView< long long const >(static_cast::pointer>(farg3->data), farg3->size); + arg3 = &tmpview3; + tmpview4 = Teuchos::ArrayView< double const >(static_cast::pointer>(farg4->data), farg4->size); + arg4 = &tmpview4; { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::getGlobalRowView(long long,Teuchos::ArrayView< long long const > &,Teuchos::ArrayView< double const > &) const");; @@ -12679,6 +12681,10 @@ SWIGEXPORT void _wrap_TpetraCrsMatrix_getGlobalRowView(SwigClassWrapper const *f } } + farg3->data = (void*)tmpview3.getRawPtr(); + farg3->size = tmpview3.size(); + farg4->data = (void*)tmpview4.getRawPtr(); + farg4->size = tmpview4.size(); } diff --git a/src/tpetra/test/test_tpetra_crsmatrix.F90 b/src/tpetra/test/test_tpetra_crsmatrix.F90 index 54096db2..be9e1d59 100644 --- a/src/tpetra/test/test_tpetra_crsmatrix.F90 +++ b/src/tpetra/test/test_tpetra_crsmatrix.F90 @@ -597,13 +597,14 @@ program test_TpetraCrsMatrix integer(TpetraProfileType) :: pftype integer(size_type) :: num_images, my_image_id, numentries integer :: nnz - integer :: T, j + integer :: T, i integer, parameter :: lclrow=1 logical :: opt_storage - real(norm_type) :: norms(1) - real(scalar_type) :: scopy(4), csview(4) - integer :: lcopy(4), clview(4), i - integer(global_ordinal_type) :: gcopy(4), cgview(4) + real(scalar_type) :: scopy(4) + integer :: lcopy(4) + integer(global_ordinal_type) :: gcopy(4) + integer(global_ordinal_type), pointer :: cgptr(:) + real(scalar_type), pointer :: csptr(:) integer(global_ordinal_type) :: gblrow integer, allocatable :: linds(:) integer(global_ordinal_type), allocatable :: ginds(:), mask(:) @@ -664,7 +665,7 @@ program test_TpetraCrsMatrix ! at this point, the graph has not allocated data as global or local, so ! we can do views/copies for either local or global call A%getLocalRowCopy(lclrow, lcopy, scopy, numentries) - !call A%getLocalRowView(lclrow, clview, csview) + !call A%getLocalRowView(lclrow, clview, csptr) call A%getGlobalRowCopy(gblrow, gcopy, scopy, numentries) call A%insertGlobalValues(gblrow, ginds, values) @@ -672,23 +673,23 @@ program test_TpetraCrsMatrix ! check values before calling fillComplete allocate(mask(nnz)) mask = -1 - call A%getGlobalRowView(gblrow, cgview(1:nnz), csview(1:nnz)) + call A%getGlobalRowView(gblrow, cgptr, csptr) do i=1, nnz; - where(ginds(i)==cgview) mask = i + where(ginds(i)==cgptr) mask = i end do TEST_ASSERT((.not. any(mask==-1))) - TEST_ARRAY_EQUALITY(cgview(mask), ginds) - TEST_FLOATING_ARRAY_EQUALITY(csview(mask), values, epsilon(0.d0)) + TEST_ARRAY_EQUALITY(cgptr(mask), ginds) + TEST_FLOATING_ARRAY_EQUALITY(csptr(mask), values, epsilon(0.d0)) deallocate(mask) call A%fillComplete(params); ! check for throws and no-throws/values - TEST_THROW(call A%getGlobalRowView(gblrow, cgview, csview)) + TEST_THROW(call A%getGlobalRowView(gblrow, cgptr, csptr)) - !TEST_NOTHROW(call A%getLocalRowView(lclrow, clview, csview)) + !TEST_NOTHROW(call A%getLocalRowView(lclrow, clview, csptr)) !TEST_ARRAY_EQUALITY(clview, linds) - !TEST_FLOATING_ARRAY_EQUALITY(csview, values, epsilon(0.d0)) + !TEST_FLOATING_ARRAY_EQUALITY(csptr, values, epsilon(0.d0)) TEST_NOTHROW(call A%getLocalRowCopy(lclrow, lcopy, scopy, numentries)) TEST_ARRAY_EQUALITY(lcopy(1:numentries), linds) diff --git a/src/utils/src/swig/forerror.F90 b/src/utils/src/swig/forerror.F90 index f29db969..68d591ca 100644 --- a/src/utils/src/swig/forerror.F90 +++ b/src/utils/src/swig/forerror.F90 @@ -55,7 +55,7 @@ subroutine SWIG_chararray_to_string(wrap, string) allocate(character(kind=C_CHAR, len=wrap%size) :: string) do i=1, wrap%size string(i:i) = chars(i) - enddo + end do end subroutine function fortrilinos_get_serr() & diff --git a/swig_hash b/swig_hash index bd3c048f..729c09d0 100644 --- a/swig_hash +++ b/swig_hash @@ -1 +1 @@ -eea2a05f6 +cefd405afbacffd4c8932d1d748ed490bd5381fe From 2b04a718ca844f9f13d80495bb36d717a48b0efa Mon Sep 17 00:00:00 2001 From: Seth R Johnson Date: Wed, 6 Feb 2019 11:32:54 -0500 Subject: [PATCH 29/40] Add typemap for array RCP --- src/teuchos/src/Teuchos_ArrayRCP.i | 100 + src/teuchos/src/forteuchos.i | 1 + src/teuchos/src/swig/forteuchos.F90 | 126 +- .../src/swig/forteuchosFORTRAN_wrap.cxx | 115 +- src/tpetra/src/Tpetra_CrsGraph.i | 49 +- src/tpetra/src/Tpetra_CrsMatrix.i | 49 +- src/tpetra/src/fortpetra.i | 14 + src/tpetra/src/swig/fortpetra.F90 | 2522 +++++++++-------- src/tpetra/src/swig/fortpetraFORTRAN_wrap.cxx | 1923 +++++++------ 9 files changed, 2600 insertions(+), 2299 deletions(-) create mode 100644 src/teuchos/src/Teuchos_ArrayRCP.i diff --git a/src/teuchos/src/Teuchos_ArrayRCP.i b/src/teuchos/src/Teuchos_ArrayRCP.i new file mode 100644 index 00000000..58131439 --- /dev/null +++ b/src/teuchos/src/Teuchos_ArrayRCP.i @@ -0,0 +1,100 @@ +/* + * Copyright 2017-2018, UT-Battelle, LLC + * + * SPDX-License-Identifier: BSD-3-Clause + * License-Filename: LICENSE + */ +%{ +#include "Teuchos_ArrayRCP.hpp" +%} + +%include + +namespace Teuchos +{ +template +class ArrayRCP +{ + public: + typedef _Tp value_type; + typedef std::size_t size_type; + +#if 0 + // Rename 'call' operator to 'view' + %rename(view) operator(); + + // Add accessors to get a view + ArrayRCP<_Tp> operator()(size_type lowerOffset, size_type size) const; + ArrayRCP<_Tp> operator()() const; + + // Smart pointer attributes + int strong_count() const; + int weak_count() const; + int total_count() const; + bool has_ownership() const; +#endif + + // Add native wrapping typemaps to convert *input* to Teuchos RCP + %fortran_array_pointer(_Tp, ArrayRCP<_Tp>) + %apply ArrayRCP<_Tp> { const ArrayRCP<_Tp> & } + + // Output isn't currently implemented + %typemap(out) ArrayRCP<_Tp> + "#error Can't return $type by value" + %typemap(out) const ArrayRCP<_Tp>& + "#error Can't return $type by const reference" + + // Wrap RCP by value + %typemap(in, noblock=1) ArrayRCP<_Tp> { + $1 = Teuchos::ArrayRCP<_Tp>(static_cast<_Tp*>($input->data), 0, $input->size, false, Teuchos::RCP_DISABLE_NODE_LOOKUP); + } + // Wrap RCP by const reference + %typemap(in, noblock=1) const ArrayRCP<_Tp>& (ArrayRCP<_Tp> tmparr) { + tmparr = Teuchos::ArrayRCP<_Tp>(static_cast<_Tp*>($input->data), 0, $input->size, false, Teuchos::RCP_DISABLE_NODE_LOOKUP); + $1 = &tmparr; + } + +}; +} + +%template() Teuchos::ArrayRCP; +%template() Teuchos::ArrayRCP; +%template() Teuchos::ArrayRCP; + +%template() Teuchos::ArrayRCP; +%template() Teuchos::ArrayRCP; +%template() Teuchos::ArrayRCP; + +%template() Teuchos::ArrayRCP; +%template() Teuchos::ArrayRCP; +%template() Teuchos::ArrayRCP; + +%template() Teuchos::ArrayRCP; +%template() Teuchos::ArrayRCP; +%template() Teuchos::ArrayRCP; + +#if 0 +%define %teuchos_template_arrayrcp(EXT, CPPTYPE) + +// Only instantiate non-const +%template(ArrayRCP ## EXT) Teuchos::ArrayRCP; + +// Use non-const typemaps for RCP-to-const +%apply Teuchos::ArrayRCP { Teuchos::ArrayRCP }; + +// Use arcp const cast to convert mutable to const +%typemap(in, noblock=1) Teuchos::ArrayRCP +(Teuchos::ArrayRCP* origrcp) { + SWIG_check_nonnull(*$input, "$1_ltype", "$fclassname", "$decl", return $null); + origrcp = %static_cast($input->cptr, Teuchos::ArrayRCP*); + $1 = Teuchos::arcp_const_cast(*origrcp); +} + +%enddef + +// Instantiate typemaps only +%template(ArrayRCP_Int) Teuchos::ArrayRCP; +%template(ArrayRCP_Dbl) Teuchos::ArrayRCP; +%template(ArrayRCP_Longlong) Teuchos::ArrayRCP; +#endif + diff --git a/src/teuchos/src/forteuchos.i b/src/teuchos/src/forteuchos.i index e067aecf..63a62c68 100644 --- a/src/teuchos/src/forteuchos.i +++ b/src/teuchos/src/forteuchos.i @@ -51,6 +51,7 @@ typedef int Teuchos_Ordinal; %include "Teuchos_RCP.i" %include "Teuchos_ArrayView.i" +%include "Teuchos_ArrayRCP.i" %include "Teuchos_Array.i" %include "Teuchos_Comm.i" %include "Teuchos_ParameterList.i" diff --git a/src/teuchos/src/swig/forteuchos.F90 b/src/teuchos/src/swig/forteuchos.F90 index bec87902..b85d3a61 100644 --- a/src/teuchos/src/swig/forteuchos.F90 +++ b/src/teuchos/src/swig/forteuchos.F90 @@ -65,6 +65,12 @@ module forteuchos end enum integer, parameter, public :: TeuchosDataAccess = kind(TeuchosCopy) public :: TeuchosCopy, TeuchosView + type, bind(C) :: SwigArrayWrapper + type(C_PTR), public :: data = C_NULL_PTR + integer(C_SIZE_T), public :: size = 0 + end type + public :: value + public :: cref enum, bind(c) enumerator :: SWIG_NULL enumerator :: SWIG_OWN @@ -77,10 +83,6 @@ module forteuchos type(C_PTR), public :: cptr = C_NULL_PTR integer(C_INT), public :: mem = SWIG_NULL end type - type, bind(C) :: SwigArrayWrapper - type(C_PTR), public :: data = C_NULL_PTR - integer(C_SIZE_T), public :: size = 0 - end type ! class Teuchos::Array< int > type, public :: TeuchosArrayInt type(SwigClassWrapper), public :: swigdata @@ -173,6 +175,20 @@ module forteuchos ! WRAPPER DECLARATIONS interface +subroutine swigc_value(farg1) & +bind(C, name="_wrap_value") +use, intrinsic :: ISO_C_BINDING +import :: swigarraywrapper +type(SwigArrayWrapper) :: farg1 +end subroutine + +subroutine swigc_cref(farg1) & +bind(C, name="_wrap_cref") +use, intrinsic :: ISO_C_BINDING +import :: swigarraywrapper +type(SwigArrayWrapper) :: farg1 +end subroutine + function swigc_new_TeuchosArrayInt(farg1) & bind(C, name="_wrap_new_TeuchosArrayInt") & result(fresult) @@ -611,6 +627,42 @@ subroutine swigc_save_to_xml(farg1, farg2) & contains ! MODULE SUBPROGRAMS +subroutine value(a) +use, intrinsic :: ISO_C_BINDING +integer(C_INT), dimension(:), target :: a +integer(C_INT), pointer :: farg1_view + +type(SwigArrayWrapper) :: farg1 + +if (size(a) > 0) then +farg1_view => a(1) +farg1%data = c_loc(farg1_view) +farg1%size = size(a) +else +farg1%data = c_null_ptr +farg1%size = 0 +end if +call swigc_value(farg1) +end subroutine + +subroutine cref(a) +use, intrinsic :: ISO_C_BINDING +integer(C_INT), dimension(:), target :: a +integer(C_INT), pointer :: farg1_view + +type(SwigArrayWrapper) :: farg1 + +if (size(a) > 0) then +farg1_view => a(1) +farg1%data = c_loc(farg1_view) +farg1%size = size(a) +else +farg1%data = c_null_ptr +farg1%size = 0 +end if +call swigc_cref(farg1) +end subroutine + function new_TeuchosArrayInt(arg0) & result(self) use, intrinsic :: ISO_C_BINDING @@ -1008,13 +1060,13 @@ function swigf_ParameterList_sublist(self, name) & swig_result%swigdata = fresult end function -subroutine swigf_ParameterList_set__SWIG_1(self, name, value) +subroutine swigf_ParameterList_set__SWIG_1(self, name, value2) use, intrinsic :: ISO_C_BINDING class(ParameterList), intent(inout) :: self character(kind=C_CHAR, len=*), target :: name character(kind=C_CHAR), dimension(:), allocatable, target :: farg2_chars -real(C_DOUBLE), intent(in) :: value +real(C_DOUBLE), intent(in) :: value2 type(SwigClassWrapper) :: farg1 type(SwigArrayWrapper) :: farg2 @@ -1022,17 +1074,17 @@ subroutine swigf_ParameterList_set__SWIG_1(self, name, value) farg1 = self%swigdata call SWIG_string_to_chararray(name, farg2_chars, farg2) -farg3 = value +farg3 = value2 call swigc_ParameterList_set__SWIG_1(farg1, farg2, farg3) end subroutine -subroutine swigf_ParameterList_set__SWIG_2(self, name, value) +subroutine swigf_ParameterList_set__SWIG_2(self, name, value2) use, intrinsic :: ISO_C_BINDING class(ParameterList), intent(inout) :: self character(kind=C_CHAR, len=*), target :: name character(kind=C_CHAR), dimension(:), allocatable, target :: farg2_chars -integer, intent(in) :: value +integer, intent(in) :: value2 type(SwigClassWrapper) :: farg1 type(SwigArrayWrapper) :: farg2 @@ -1040,17 +1092,17 @@ subroutine swigf_ParameterList_set__SWIG_2(self, name, value) farg1 = self%swigdata call SWIG_string_to_chararray(name, farg2_chars, farg2) -farg3 = value +farg3 = value2 call swigc_ParameterList_set__SWIG_2(farg1, farg2, farg3) end subroutine -subroutine swigf_ParameterList_set__SWIG_3(self, name, value) +subroutine swigf_ParameterList_set__SWIG_3(self, name, value2) use, intrinsic :: ISO_C_BINDING class(ParameterList), intent(inout) :: self character(kind=C_CHAR, len=*), target :: name character(kind=C_CHAR), dimension(:), allocatable, target :: farg2_chars -integer(C_LONG_LONG), intent(in) :: value +integer(C_LONG_LONG), intent(in) :: value2 type(SwigClassWrapper) :: farg1 type(SwigArrayWrapper) :: farg2 @@ -1058,7 +1110,7 @@ subroutine swigf_ParameterList_set__SWIG_3(self, name, value) farg1 = self%swigdata call SWIG_string_to_chararray(name, farg2_chars, farg2) -farg3 = value +farg3 = value2 call swigc_ParameterList_set__SWIG_3(farg1, farg2, farg3) end subroutine @@ -1075,13 +1127,13 @@ function SWIG_logical_to_int(inp) & end if end function -subroutine swigf_ParameterList_set__SWIG_4(self, name, value) +subroutine swigf_ParameterList_set__SWIG_4(self, name, value2) use, intrinsic :: ISO_C_BINDING class(ParameterList), intent(inout) :: self character(kind=C_CHAR, len=*), target :: name character(kind=C_CHAR), dimension(:), allocatable, target :: farg2_chars -logical, intent(in) :: value +logical, intent(in) :: value2 type(SwigClassWrapper) :: farg1 type(SwigArrayWrapper) :: farg2 @@ -1089,17 +1141,17 @@ subroutine swigf_ParameterList_set__SWIG_4(self, name, value) farg1 = self%swigdata call SWIG_string_to_chararray(name, farg2_chars, farg2) -farg3 = SWIG_logical_to_int(value) +farg3 = SWIG_logical_to_int(value2) call swigc_ParameterList_set__SWIG_4(farg1, farg2, farg3) end subroutine -subroutine swigf_ParameterList_set__SWIG_5(self, name, value) +subroutine swigf_ParameterList_set__SWIG_5(self, name, value2) use, intrinsic :: ISO_C_BINDING class(ParameterList), intent(inout) :: self character(kind=C_CHAR, len=*), target :: name character(kind=C_CHAR), dimension(:), allocatable, target :: farg2_chars -character(kind=C_CHAR, len=*), target :: value +character(kind=C_CHAR, len=*), target :: value2 character(kind=C_CHAR), dimension(:), allocatable, target :: farg3_chars type(SwigClassWrapper) :: farg1 @@ -1108,17 +1160,17 @@ subroutine swigf_ParameterList_set__SWIG_5(self, name, value) farg1 = self%swigdata call SWIG_string_to_chararray(name, farg2_chars, farg2) -call SWIG_string_to_chararray(value, farg3_chars, farg3) +call SWIG_string_to_chararray(value2, farg3_chars, farg3) call swigc_ParameterList_set__SWIG_5(farg1, farg2, farg3) end subroutine -subroutine swigf_ParameterList_set__SWIG_6(self, name, value) +subroutine swigf_ParameterList_set__SWIG_6(self, name, value2) use, intrinsic :: ISO_C_BINDING class(ParameterList), intent(inout) :: self character(kind=C_CHAR, len=*), target :: name character(kind=C_CHAR), dimension(:), allocatable, target :: farg2_chars -real(C_DOUBLE), dimension(:), target :: value +real(C_DOUBLE), dimension(:), target :: value2 real(C_DOUBLE), pointer :: farg3_view type(SwigClassWrapper) :: farg1 @@ -1127,10 +1179,10 @@ subroutine swigf_ParameterList_set__SWIG_6(self, name, value) farg1 = self%swigdata call SWIG_string_to_chararray(name, farg2_chars, farg2) -if (size(value) > 0) then -farg3_view => value(1) +if (size(value2) > 0) then +farg3_view => value2(1) farg3%data = c_loc(farg3_view) -farg3%size = size(value) +farg3%size = size(value2) else farg3%data = c_null_ptr farg3%size = 0 @@ -1138,13 +1190,13 @@ subroutine swigf_ParameterList_set__SWIG_6(self, name, value) call swigc_ParameterList_set__SWIG_6(farg1, farg2, farg3) end subroutine -subroutine swigf_ParameterList_set__SWIG_7(self, name, value) +subroutine swigf_ParameterList_set__SWIG_7(self, name, value2) use, intrinsic :: ISO_C_BINDING class(ParameterList), intent(inout) :: self character(kind=C_CHAR, len=*), target :: name character(kind=C_CHAR), dimension(:), allocatable, target :: farg2_chars -integer(C_INT), dimension(:), target :: value +integer(C_INT), dimension(:), target :: value2 integer(C_INT), pointer :: farg3_view type(SwigClassWrapper) :: farg1 @@ -1153,10 +1205,10 @@ subroutine swigf_ParameterList_set__SWIG_7(self, name, value) farg1 = self%swigdata call SWIG_string_to_chararray(name, farg2_chars, farg2) -if (size(value) > 0) then -farg3_view => value(1) +if (size(value2) > 0) then +farg3_view => value2(1) farg3%data = c_loc(farg3_view) -farg3%size = size(value) +farg3%size = size(value2) else farg3%data = c_null_ptr farg3%size = 0 @@ -1164,13 +1216,13 @@ subroutine swigf_ParameterList_set__SWIG_7(self, name, value) call swigc_ParameterList_set__SWIG_7(farg1, farg2, farg3) end subroutine -subroutine swigf_ParameterList_set__SWIG_8(self, name, value) +subroutine swigf_ParameterList_set__SWIG_8(self, name, value2) use, intrinsic :: ISO_C_BINDING class(ParameterList), intent(inout) :: self character(kind=C_CHAR, len=*), target :: name character(kind=C_CHAR), dimension(:), allocatable, target :: farg2_chars -integer(C_LONG_LONG), dimension(:), target :: value +integer(C_LONG_LONG), dimension(:), target :: value2 integer(C_LONG_LONG), pointer :: farg3_view type(SwigClassWrapper) :: farg1 @@ -1179,10 +1231,10 @@ subroutine swigf_ParameterList_set__SWIG_8(self, name, value) farg1 = self%swigdata call SWIG_string_to_chararray(name, farg2_chars, farg2) -if (size(value) > 0) then -farg3_view => value(1) +if (size(value2) > 0) then +farg3_view => value2(1) farg3%data = c_loc(farg3_view) -farg3%size = size(value) +farg3%size = size(value2) else farg3%data = c_null_ptr farg3%size = 0 @@ -1190,13 +1242,13 @@ subroutine swigf_ParameterList_set__SWIG_8(self, name, value) call swigc_ParameterList_set__SWIG_8(farg1, farg2, farg3) end subroutine -subroutine swigf_ParameterList_set__SWIG_9(self, name, value) +subroutine swigf_ParameterList_set__SWIG_9(self, name, value2) use, intrinsic :: ISO_C_BINDING class(ParameterList), intent(inout) :: self character(kind=C_CHAR, len=*), target :: name character(kind=C_CHAR), dimension(:), allocatable, target :: farg2_chars -class(ParameterList), intent(in) :: value +class(ParameterList), intent(in) :: value2 type(SwigClassWrapper) :: farg1 type(SwigArrayWrapper) :: farg2 @@ -1204,7 +1256,7 @@ subroutine swigf_ParameterList_set__SWIG_9(self, name, value) farg1 = self%swigdata call SWIG_string_to_chararray(name, farg2_chars, farg2) -farg3 = value%swigdata +farg3 = value2%swigdata call swigc_ParameterList_set__SWIG_9(farg1, farg2, farg3) end subroutine diff --git a/src/teuchos/src/swig/forteuchosFORTRAN_wrap.cxx b/src/teuchos/src/swig/forteuchosFORTRAN_wrap.cxx index 28a4912e..60b8a307 100644 --- a/src/teuchos/src/swig/forteuchosFORTRAN_wrap.cxx +++ b/src/teuchos/src/swig/forteuchosFORTRAN_wrap.cxx @@ -290,29 +290,12 @@ struct assignment_flags; #include "Teuchos_ArrayView.hpp" -#include "Teuchos_Array.hpp" - - -enum SwigMemState { - SWIG_NULL, - SWIG_OWN, - SWIG_MOVE, - SWIG_REF, - SWIG_CREF -}; - - -struct SwigClassWrapper { - void* cptr; - SwigMemState mem; -}; +#include "Teuchos_ArrayRCP.hpp" -SWIGINTERN SwigClassWrapper SwigClassWrapper_uninitialized() { - SwigClassWrapper result; - result.cptr = NULL; - result.mem = SWIG_NULL; - return result; +namespace Teuchos { +void value(Teuchos::ArrayRCP a) { } +void cref(const Teuchos::ArrayRCP& a) { } } @@ -340,6 +323,32 @@ SWIGINTERN SwigArrayWrapper SwigArrayWrapper_uninitialized() { return result; } + +#include "Teuchos_Array.hpp" + + +enum SwigMemState { + SWIG_NULL, + SWIG_OWN, + SWIG_MOVE, + SWIG_REF, + SWIG_CREF +}; + + +struct SwigClassWrapper { + void* cptr; + SwigMemState mem; +}; + + +SWIGINTERN SwigClassWrapper SwigClassWrapper_uninitialized() { + SwigClassWrapper result; + result.cptr = NULL; + result.mem = SWIG_NULL; + return result; +} + SWIGINTERN Teuchos::ArrayView< int > Teuchos_Array_Sl_int_Sg__view(Teuchos::Array< int > *self){ return (*self)(); } @@ -641,6 +650,70 @@ void save_to_xml(const Teuchos::ParameterList& plist, #ifdef __cplusplus extern "C" { #endif +SWIGEXPORT void _wrap_value(SwigArrayWrapper *farg1) { + Teuchos::ArrayRCP< int > arg1 ; + + arg1 = Teuchos::ArrayRCP(static_cast(farg1->data), 0, farg1->size, false, Teuchos::RCP_DISABLE_NODE_LOOKUP); + { + // Make sure no unhandled exceptions exist before performing a new action + SWIG_check_unhandled_exception_impl("Teuchos::value(Teuchos::ArrayRCP< int >)");; + try + { + // Attempt the wrapped function call + Teuchos::value(arg1); + } + catch (const std::range_error& e) + { + // Store a C++ exception + SWIG_exception_impl("Teuchos::value(Teuchos::ArrayRCP< int >)", SWIG_IndexError, e.what(), return ); + } + catch (const std::exception& e) + { + // Store a C++ exception + SWIG_exception_impl("Teuchos::value(Teuchos::ArrayRCP< int >)", SWIG_RuntimeError, e.what(), return ); + } + catch (...) + { + SWIG_exception_impl("Teuchos::value(Teuchos::ArrayRCP< int >)", SWIG_UnknownError, "An unknown exception occurred", return ); + } + } + +} + + +SWIGEXPORT void _wrap_cref(SwigArrayWrapper *farg1) { + Teuchos::ArrayRCP< int > *arg1 = 0 ; + Teuchos::ArrayRCP< int > tmparr1 ; + + tmparr1 = Teuchos::ArrayRCP(static_cast(farg1->data), 0, farg1->size, false, Teuchos::RCP_DISABLE_NODE_LOOKUP); + arg1 = &tmparr1; + { + // Make sure no unhandled exceptions exist before performing a new action + SWIG_check_unhandled_exception_impl("Teuchos::cref(Teuchos::ArrayRCP< int > const &)");; + try + { + // Attempt the wrapped function call + Teuchos::cref((Teuchos::ArrayRCP< int > const &)*arg1); + } + catch (const std::range_error& e) + { + // Store a C++ exception + SWIG_exception_impl("Teuchos::cref(Teuchos::ArrayRCP< int > const &)", SWIG_IndexError, e.what(), return ); + } + catch (const std::exception& e) + { + // Store a C++ exception + SWIG_exception_impl("Teuchos::cref(Teuchos::ArrayRCP< int > const &)", SWIG_RuntimeError, e.what(), return ); + } + catch (...) + { + SWIG_exception_impl("Teuchos::cref(Teuchos::ArrayRCP< int > const &)", SWIG_UnknownError, "An unknown exception occurred", return ); + } + } + +} + + SWIGEXPORT SwigClassWrapper _wrap_new_TeuchosArrayInt(SwigArrayWrapper *farg1) { SwigClassWrapper fresult ; Teuchos::ArrayView< int const > *arg1 = 0 ; diff --git a/src/tpetra/src/Tpetra_CrsGraph.i b/src/tpetra/src/Tpetra_CrsGraph.i index 8d47bff7..53cfb7b4 100644 --- a/src/tpetra/src/Tpetra_CrsGraph.i +++ b/src/tpetra/src/Tpetra_CrsGraph.i @@ -79,7 +79,13 @@ %apply const Teuchos::ArrayView& INDEX { const Teuchos::ArrayView& indices } -%apply const Teuchos::ArrayView& INDEX { const Teuchos::ArrayView& indices } +%apply const Teuchos::ArrayView& INDEX { + const Teuchos::ArrayView& indices } + +%apply const Teuchos::ArrayRCP& INDEX { + const Teuchos::ArrayRCP& rowPointers, + const Teuchos::ArrayRCP& columnIndices +} %apply int { size_t getNumEntriesInLocalRow, size_t getNumAllocatedEntriesInLocalRow} @@ -88,33 +94,6 @@ // Make interface more Fortran friendly // ======================================================================= %extend Tpetra::CrsGraph { - CrsGraph(const Teuchos::RCP< const map_type > &rowMap, - Teuchos::ArrayView numEntPerRow, - const ProfileType pftype=DynamicProfile, - const Teuchos::RCP< Teuchos::ParameterList > ¶ms=Teuchos::null) { - return new Tpetra::CrsGraph(rowMap, arcpFromArrayView(numEntPerRow), pftype, params); - } - CrsGraph(const Teuchos::RCP< const map_type > &rowMap, - const Teuchos::RCP< const map_type > &colMap, - Teuchos::ArrayView numEntPerRow, - const ProfileType pftype=DynamicProfile, - const Teuchos::RCP< Teuchos::ParameterList > ¶ms=Teuchos::null) { - return new Tpetra::CrsGraph(rowMap, colMap, arcpFromArrayView(numEntPerRow), pftype, params); - } - CrsGraph(const Teuchos::RCP< const map_type > &rowMap, - const Teuchos::RCP< const map_type > &colMap, - Teuchos::ArrayView rowPointers, - Teuchos::ArrayView columnIndices, - const Teuchos::RCP< Teuchos::ParameterList > ¶ms=Teuchos::null) { - Teuchos::Array rowPointersArray(rowPointers.size()); - for (size_t i = 0; i < rowPointers.size(); i++) - rowPointersArray[i] = rowPointers[i]-1; - Teuchos::Array columnIndicesArray(columnIndices.size()); - for (size_t i = 0; i < columnIndices.size(); i++) - columnIndicesArray[i] = columnIndices[i]-1; - return new Tpetra::CrsGraph(rowMap, colMap, - Teuchos::arcpFromArray(rowPointersArray), Teuchos::arcpFromArray(columnIndicesArray), params); - } // NOTE: This is semantically different function from Tpetra. Here, we *require* that user already allocated the arrays to store the data void getNodeRowPtrs(Teuchos::ArrayView rowPointers) const { auto rowPointersArrayRCP = $self->getNodeRowPtrs(); @@ -135,23 +114,9 @@ // Add doImport and doExport %tpetra_extend_with_import_export(Tpetra::CrsGraph) -%ignore Tpetra::CrsGraph::CrsGraph (const Teuchos::RCP< const map_type > &rowMap, - const Teuchos::ArrayRCP< const size_t > &numEntPerRow, - const ProfileType pftype=DynamicProfile, - const Teuchos::RCP< Teuchos::ParameterList > ¶ms=Teuchos::null); -%ignore Tpetra::CrsGraph::CrsGraph (const Teuchos::RCP& rowMap, const Teuchos::RCP& colMap, - const Teuchos::ArrayRCP& numEntPerRow, - const ProfileType pftype = DynamicProfile, - const Teuchos::RCP& params = Teuchos::null); -%ignore Tpetra::CrsGraph::CrsGraph (const Teuchos::RCP< const map_type > &rowMap, - const Teuchos::RCP< const map_type > &colMap, - const Teuchos::ArrayRCP< size_t > &rowPointers, - const Teuchos::ArrayRCP< LocalOrdinal > &columnIndices, - const Teuchos::RCP< Teuchos::ParameterList > ¶ms=Teuchos::null); // needs Teuchos::ArrayRCP; ±1 issue %ignore Tpetra::CrsGraph::getNodeRowPtrs() const; %ignore Tpetra::CrsGraph::getNodePackedIndices() const; %ignore Tpetra::CrsGraph::getLocalDiagOffsets; -%ignore Tpetra::CrsGraph::setAllIndices (const Teuchos::ArrayRCP< size_t > &rowPointers, const Teuchos::ArrayRCP< LocalOrdinal > &columnIndices); %ignore Tpetra::CrsGraph::setAllIndices (const typename local_graph_type::row_map_type &rowPointers, const typename local_graph_type::entries_type::non_const_type &columnIndices); diff --git a/src/tpetra/src/Tpetra_CrsMatrix.i b/src/tpetra/src/Tpetra_CrsMatrix.i index 7e295725..fbf34d23 100644 --- a/src/tpetra/src/Tpetra_CrsMatrix.i +++ b/src/tpetra/src/Tpetra_CrsMatrix.i @@ -88,6 +88,13 @@ %apply const Teuchos::ArrayView& INDEX { const Teuchos::ArrayView& colInds } +%apply const Teuchos::ArrayRCP& INDEX { + const Teuchos::ArrayRCP& rowPointers, + const Teuchos::ArrayRCP& columnIndices, + const Teuchos::ArrayRCP& ptr, + const Teuchos::ArrayRCP& ind +} + // Don't use atomics for value summation %typemap(in,numinputs=0) bool atomic { $1 = false; @@ -97,31 +104,6 @@ // Make interface more Fortran friendly // ======================================================================= %extend Tpetra::CrsMatrix { - CrsMatrix(const Teuchos::RCP& rowMap, Teuchos::ArrayView NumEntriesPerRowToAlloc, ProfileType pftype = DynamicProfile, const Teuchos::RCP& params = Teuchos::null) { - return new Tpetra::CrsMatrix(rowMap, arcpFromArrayView(NumEntriesPerRowToAlloc), pftype, params); - } - CrsMatrix(const Teuchos::RCP& rowMap, const Teuchos::RCP& colMap, Teuchos::ArrayView NumEntriesPerRowToAlloc, ProfileType pftype = DynamicProfile, const Teuchos::RCP& params = Teuchos::null) { - return new Tpetra::CrsMatrix(rowMap, colMap, arcpFromArrayView(NumEntriesPerRowToAlloc), pftype, params); - } - CrsMatrix (const Teuchos::RCP& rowMap, const Teuchos::RCP& colMap, Teuchos::ArrayView rowPointers, Teuchos::ArrayView columnIndices, Teuchos::ArrayView values, const Teuchos::RCP& params = Teuchos::null) { - Teuchos::ArrayRCP rowPointersArrayRCP(rowPointers.size()); - for (int i = 0; i < rowPointersArrayRCP.size(); i++) - rowPointersArrayRCP[i] = rowPointers[i]-1; - Teuchos::ArrayRCP columnIndicesArrayRCP(columnIndices.size()); - for (int i = 0; i < columnIndicesArrayRCP.size(); i++) - columnIndicesArrayRCP[i] = columnIndices[i]-1; - return new Tpetra::CrsMatrix(rowMap, colMap, rowPointersArrayRCP, columnIndicesArrayRCP, arcpFromArrayView(values), params); - } - void setAllValues(Teuchos::ArrayView ptr, Teuchos::ArrayView ind, Teuchos::ArrayView val) { - Teuchos::ArrayRCP ptrArrayRCP(ptr.size()); - for (int i = 0; i < ptrArrayRCP.size(); i++) - ptrArrayRCP[i] = ptr[i]-1; - Teuchos::ArrayRCP indArrayRCP(ind.size()); - for (int i = 0; i < indArrayRCP.size(); i++) - indArrayRCP[i] = ind[i]-1; - Teuchos::ArrayRCP valArrayRCP(val.getRawPtr(), 0, val.size(), false/*has_ownership*/); - $self->setAllValues(arcpFromArrayView(ptr), arcpFromArrayView(ind), arcpFromArrayView(val)); - } // NOTE: This is semantically different function from Tpetra. Here, we *require* that user already allocated the arrays to store the data void getAllValues(Teuchos::ArrayView rowPointers, Teuchos::ArrayView columnIndices, Teuchos::ArrayView values) const { Teuchos::ArrayRCP rowPointersArrayRCP; @@ -145,26 +127,9 @@ // Add doImport and doExport %tpetra_extend_with_import_export(Tpetra::CrsGraph) -%ignore Tpetra::CrsMatrix::CrsMatrix (const Teuchos::RCP& rowMap, - const Teuchos::ArrayRCP& NumEntriesPerRowToAlloc, - ProfileType pftype = DynamicProfile, - const Teuchos::RCP& params = Teuchos::null); // needs ArrayRCP -%ignore Tpetra::CrsMatrix::CrsMatrix (const Teuchos::RCP& rowMap, - const Teuchos::RCP& colMap, - const Teuchos::ArrayRCP& NumEntriesPerRowToAlloc, - ProfileType pftype = DynamicProfile, - const Teuchos::RCP& params = Teuchos::null); // needs ArrayRCP -%ignore Tpetra::CrsMatrix::CrsMatrix (const Teuchos::RCP& rowMap, - const Teuchos::RCP& colMap, - const Teuchos::ArrayRCP& rowPointers, - const Teuchos::ArrayRCP& columnIndices, - const Teuchos::ArrayRCP& values, - const Teuchos::RCP& params = Teuchos::null); // needs Teuchos::ArrayRCP -%ignore Tpetra::CrsMatrix::setAllValues(const Teuchos::ArrayRCP< size_t > &ptr, const Teuchos::ArrayRCP< LocalOrdinal > &ind, const Teuchos::ArrayRCP< Scalar > &val); %ignore Tpetra::CrsMatrix::getAllValues(Teuchos::ArrayRCP< const size_t > &rowPointers, Teuchos::ArrayRCP< const LocalOrdinal > &columnIndices, Teuchos::ArrayRCP< const Scalar > &values) const; %ignore Tpetra::CrsMatrix::getLocalRowViewRaw(const LocalOrdinal lclRow, LocalOrdinal &numEnt, const LocalOrdinal *&lclColInds, const Scalar *&vals) const; %ignore Tpetra::CrsMatrix::getAllValues (Teuchos::ArrayRCP& rowPointers, Teuchos::ArrayRCP& columnIndices, Teuchos::ArrayRCP& values) const; -%ignore Tpetra::CrsMatrix::getLocalDiagOffsets; // needs Teuchos::ArrayRCP %ignore Tpetra::CrsMatrix::sumIntoLocalValues (const LocalOrdinal localRow, const typename UnmanagedView< LocalIndicesViewType >::type &inputInds, const typename UnmanagedView< ImplScalarViewType >::type &inputVals, const bool atomic=useAtomicUpdatesByDefault) const; %ignore Tpetra::CrsMatrix::sumIntoLocalValues (const LocalOrdinal localRow, const LocalOrdinal numEnt, const Scalar vals[], const LocalOrdinal cols[], const bool atomic=useAtomicUpdatesByDefault); diff --git a/src/tpetra/src/fortpetra.i b/src/tpetra/src/fortpetra.i index 0d22906a..44c10ae1 100644 --- a/src/tpetra/src/fortpetra.i +++ b/src/tpetra/src/fortpetra.i @@ -89,6 +89,20 @@ public :: norm_type $1 = &tmpview; } +// *Input* fortran indices as an RCP +%typemap(in, fragment="", noblock=1) const Teuchos::ArrayRCP& INDEX + ($1_basetype::value_type* tmpbegin, + Teuchos::ArrayRCP::type> tmparr, + $1_basetype tmprcp) +{ + tmpbegin = static_cast<$1_basetype::value_type*>($input->data); + tmparr.resize($input->size); + for (int i = 0; i < tmparr.size(); i++) + tmparr[i] = tmpbegin[i] - 1; + tmprcp = tmparr; + $1 = &tmprcp; +} + // Passing a *mutable* array view by const reference: increment the result // before returning %typemap(argout, noblock=1) const Teuchos::ArrayView& INDEX diff --git a/src/tpetra/src/swig/fortpetra.F90 b/src/tpetra/src/swig/fortpetra.F90 index 72a5321a..522f1c2f 100644 --- a/src/tpetra/src/swig/fortpetra.F90 +++ b/src/tpetra/src/swig/fortpetra.F90 @@ -475,6 +475,9 @@ module fortpetra type, public :: SWIGTYPE_KokkosSparse__CrsMatrixT_Tpetra__CrsMatrixT_doub1E12GN type(SwigClassWrapper), public :: swigdata end type + type, public :: SWIGTYPE_Teuchos__ArrayRCPT_unsigned_long_t + type(SwigClassWrapper), public :: swigdata + end type ! class Tpetra::CrsMatrix< SC,LO,GO,NO > type, public :: TpetraCrsMatrix type(SwigClassWrapper), public :: swigdata @@ -489,6 +492,7 @@ module fortpetra procedure, private :: sumIntoLocalValues__SWIG_0 => swigf_TpetraCrsMatrix_sumIntoLocalValues__SWIG_0 procedure :: setAllToScalar => swigf_TpetraCrsMatrix_setAllToScalar procedure :: scale => swigf_TpetraCrsMatrix_scale + procedure :: setAllValues => swigf_TpetraCrsMatrix_setAllValues procedure :: globalAssemble => swigf_TpetraCrsMatrix_globalAssemble procedure, private :: resumeFill__SWIG_0 => swigf_TpetraCrsMatrix_resumeFill__SWIG_0 procedure, private :: resumeFill__SWIG_1 => swigf_TpetraCrsMatrix_resumeFill__SWIG_1 @@ -533,6 +537,7 @@ module fortpetra procedure :: getGlobalRowCopy => swigf_TpetraCrsMatrix_getGlobalRowCopy procedure :: getLocalRowCopy => swigf_TpetraCrsMatrix_getLocalRowCopy procedure :: getGlobalRowView => swigf_TpetraCrsMatrix_getGlobalRowView + procedure :: getLocalDiagOffsets => swigf_TpetraCrsMatrix_getLocalDiagOffsets procedure, private :: apply__SWIG_0 => swigf_TpetraCrsMatrix_apply__SWIG_0 procedure, private :: apply__SWIG_1 => swigf_TpetraCrsMatrix_apply__SWIG_1 procedure, private :: apply__SWIG_2 => swigf_TpetraCrsMatrix_apply__SWIG_2 @@ -553,7 +558,6 @@ module fortpetra procedure, private :: exportAndFillComplete__SWIG_4 => swigf_TpetraCrsMatrix_exportAndFillComplete__SWIG_4 procedure :: computeGlobalConstants => swigf_TpetraCrsMatrix_computeGlobalConstants procedure :: haveGlobalConstants => swigf_TpetraCrsMatrix_haveGlobalConstants - procedure :: setAllValues => swigf_TpetraCrsMatrix_setAllValues procedure :: getAllValues => swigf_TpetraCrsMatrix_getAllValues procedure, private :: swigf_assignment_TpetraCrsMatrix generic :: assignment(=) => swigf_assignment_TpetraCrsMatrix @@ -2176,11 +2180,47 @@ function swigc_new_TpetraCrsGraph__SWIG_2(farg1, farg2) & type(SwigClassWrapper) :: fresult end function -function swigc_new_TpetraCrsGraph__SWIG_3(farg1, farg2, farg3, farg4, farg5) & +function swigc_new_TpetraCrsGraph__SWIG_3(farg1, farg2, farg3, farg4) & bind(C, name="_wrap_new_TpetraCrsGraph__SWIG_3") & result(fresult) use, intrinsic :: ISO_C_BINDING import :: swigclasswrapper +import :: swigarraywrapper +type(SwigClassWrapper) :: farg1 +type(SwigArrayWrapper) :: farg2 +integer(C_INT), intent(in) :: farg3 +type(SwigClassWrapper) :: farg4 +type(SwigClassWrapper) :: fresult +end function + +function swigc_new_TpetraCrsGraph__SWIG_4(farg1, farg2, farg3) & +bind(C, name="_wrap_new_TpetraCrsGraph__SWIG_4") & +result(fresult) +use, intrinsic :: ISO_C_BINDING +import :: swigclasswrapper +import :: swigarraywrapper +type(SwigClassWrapper) :: farg1 +type(SwigArrayWrapper) :: farg2 +integer(C_INT), intent(in) :: farg3 +type(SwigClassWrapper) :: fresult +end function + +function swigc_new_TpetraCrsGraph__SWIG_5(farg1, farg2) & +bind(C, name="_wrap_new_TpetraCrsGraph__SWIG_5") & +result(fresult) +use, intrinsic :: ISO_C_BINDING +import :: swigclasswrapper +import :: swigarraywrapper +type(SwigClassWrapper) :: farg1 +type(SwigArrayWrapper) :: farg2 +type(SwigClassWrapper) :: fresult +end function + +function swigc_new_TpetraCrsGraph__SWIG_6(farg1, farg2, farg3, farg4, farg5) & +bind(C, name="_wrap_new_TpetraCrsGraph__SWIG_6") & +result(fresult) +use, intrinsic :: ISO_C_BINDING +import :: swigclasswrapper type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 integer(C_SIZE_T), intent(in) :: farg3 @@ -2189,8 +2229,8 @@ function swigc_new_TpetraCrsGraph__SWIG_3(farg1, farg2, farg3, farg4, farg5) & type(SwigClassWrapper) :: fresult end function -function swigc_new_TpetraCrsGraph__SWIG_4(farg1, farg2, farg3, farg4) & -bind(C, name="_wrap_new_TpetraCrsGraph__SWIG_4") & +function swigc_new_TpetraCrsGraph__SWIG_7(farg1, farg2, farg3, farg4) & +bind(C, name="_wrap_new_TpetraCrsGraph__SWIG_7") & result(fresult) use, intrinsic :: ISO_C_BINDING import :: swigclasswrapper @@ -2201,8 +2241,8 @@ function swigc_new_TpetraCrsGraph__SWIG_4(farg1, farg2, farg3, farg4) & type(SwigClassWrapper) :: fresult end function -function swigc_new_TpetraCrsGraph__SWIG_5(farg1, farg2, farg3) & -bind(C, name="_wrap_new_TpetraCrsGraph__SWIG_5") & +function swigc_new_TpetraCrsGraph__SWIG_8(farg1, farg2, farg3) & +bind(C, name="_wrap_new_TpetraCrsGraph__SWIG_8") & result(fresult) use, intrinsic :: ISO_C_BINDING import :: swigclasswrapper @@ -2212,6 +2252,72 @@ function swigc_new_TpetraCrsGraph__SWIG_5(farg1, farg2, farg3) & type(SwigClassWrapper) :: fresult end function +function swigc_new_TpetraCrsGraph__SWIG_9(farg1, farg2, farg3, farg4, farg5) & +bind(C, name="_wrap_new_TpetraCrsGraph__SWIG_9") & +result(fresult) +use, intrinsic :: ISO_C_BINDING +import :: swigclasswrapper +import :: swigarraywrapper +type(SwigClassWrapper) :: farg1 +type(SwigClassWrapper) :: farg2 +type(SwigArrayWrapper) :: farg3 +integer(C_INT), intent(in) :: farg4 +type(SwigClassWrapper) :: farg5 +type(SwigClassWrapper) :: fresult +end function + +function swigc_new_TpetraCrsGraph__SWIG_10(farg1, farg2, farg3, farg4) & +bind(C, name="_wrap_new_TpetraCrsGraph__SWIG_10") & +result(fresult) +use, intrinsic :: ISO_C_BINDING +import :: swigclasswrapper +import :: swigarraywrapper +type(SwigClassWrapper) :: farg1 +type(SwigClassWrapper) :: farg2 +type(SwigArrayWrapper) :: farg3 +integer(C_INT), intent(in) :: farg4 +type(SwigClassWrapper) :: fresult +end function + +function swigc_new_TpetraCrsGraph__SWIG_11(farg1, farg2, farg3) & +bind(C, name="_wrap_new_TpetraCrsGraph__SWIG_11") & +result(fresult) +use, intrinsic :: ISO_C_BINDING +import :: swigclasswrapper +import :: swigarraywrapper +type(SwigClassWrapper) :: farg1 +type(SwigClassWrapper) :: farg2 +type(SwigArrayWrapper) :: farg3 +type(SwigClassWrapper) :: fresult +end function + +function swigc_new_TpetraCrsGraph__SWIG_12(farg1, farg2, farg3, farg4, farg5) & +bind(C, name="_wrap_new_TpetraCrsGraph__SWIG_12") & +result(fresult) +use, intrinsic :: ISO_C_BINDING +import :: swigclasswrapper +import :: swigarraywrapper +type(SwigClassWrapper) :: farg1 +type(SwigClassWrapper) :: farg2 +type(SwigArrayWrapper) :: farg3 +type(SwigArrayWrapper) :: farg4 +type(SwigClassWrapper) :: farg5 +type(SwigClassWrapper) :: fresult +end function + +function swigc_new_TpetraCrsGraph__SWIG_13(farg1, farg2, farg3, farg4) & +bind(C, name="_wrap_new_TpetraCrsGraph__SWIG_13") & +result(fresult) +use, intrinsic :: ISO_C_BINDING +import :: swigclasswrapper +import :: swigarraywrapper +type(SwigClassWrapper) :: farg1 +type(SwigClassWrapper) :: farg2 +type(SwigArrayWrapper) :: farg3 +type(SwigArrayWrapper) :: farg4 +type(SwigClassWrapper) :: fresult +end function + subroutine swigc_delete_TpetraCrsGraph(farg1) & bind(C, name="_wrap_delete_TpetraCrsGraph") use, intrinsic :: ISO_C_BINDING @@ -2847,108 +2953,6 @@ subroutine swigc_TpetraCrsGraph_computeGlobalConstants(farg1, farg2) & integer(C_INT), intent(in) :: farg2 end subroutine -function swigc_new_TpetraCrsGraph__SWIG_6(farg1, farg2, farg3, farg4) & -bind(C, name="_wrap_new_TpetraCrsGraph__SWIG_6") & -result(fresult) -use, intrinsic :: ISO_C_BINDING -import :: swigclasswrapper -import :: swigarraywrapper -type(SwigClassWrapper) :: farg1 -type(SwigArrayWrapper) :: farg2 -integer(C_INT), intent(in) :: farg3 -type(SwigClassWrapper) :: farg4 -type(SwigClassWrapper) :: fresult -end function - -function swigc_new_TpetraCrsGraph__SWIG_7(farg1, farg2, farg3) & -bind(C, name="_wrap_new_TpetraCrsGraph__SWIG_7") & -result(fresult) -use, intrinsic :: ISO_C_BINDING -import :: swigclasswrapper -import :: swigarraywrapper -type(SwigClassWrapper) :: farg1 -type(SwigArrayWrapper) :: farg2 -integer(C_INT), intent(in) :: farg3 -type(SwigClassWrapper) :: fresult -end function - -function swigc_new_TpetraCrsGraph__SWIG_8(farg1, farg2) & -bind(C, name="_wrap_new_TpetraCrsGraph__SWIG_8") & -result(fresult) -use, intrinsic :: ISO_C_BINDING -import :: swigclasswrapper -import :: swigarraywrapper -type(SwigClassWrapper) :: farg1 -type(SwigArrayWrapper) :: farg2 -type(SwigClassWrapper) :: fresult -end function - -function swigc_new_TpetraCrsGraph__SWIG_9(farg1, farg2, farg3, farg4, farg5) & -bind(C, name="_wrap_new_TpetraCrsGraph__SWIG_9") & -result(fresult) -use, intrinsic :: ISO_C_BINDING -import :: swigclasswrapper -import :: swigarraywrapper -type(SwigClassWrapper) :: farg1 -type(SwigClassWrapper) :: farg2 -type(SwigArrayWrapper) :: farg3 -integer(C_INT), intent(in) :: farg4 -type(SwigClassWrapper) :: farg5 -type(SwigClassWrapper) :: fresult -end function - -function swigc_new_TpetraCrsGraph__SWIG_10(farg1, farg2, farg3, farg4) & -bind(C, name="_wrap_new_TpetraCrsGraph__SWIG_10") & -result(fresult) -use, intrinsic :: ISO_C_BINDING -import :: swigclasswrapper -import :: swigarraywrapper -type(SwigClassWrapper) :: farg1 -type(SwigClassWrapper) :: farg2 -type(SwigArrayWrapper) :: farg3 -integer(C_INT), intent(in) :: farg4 -type(SwigClassWrapper) :: fresult -end function - -function swigc_new_TpetraCrsGraph__SWIG_11(farg1, farg2, farg3) & -bind(C, name="_wrap_new_TpetraCrsGraph__SWIG_11") & -result(fresult) -use, intrinsic :: ISO_C_BINDING -import :: swigclasswrapper -import :: swigarraywrapper -type(SwigClassWrapper) :: farg1 -type(SwigClassWrapper) :: farg2 -type(SwigArrayWrapper) :: farg3 -type(SwigClassWrapper) :: fresult -end function - -function swigc_new_TpetraCrsGraph__SWIG_12(farg1, farg2, farg3, farg4, farg5) & -bind(C, name="_wrap_new_TpetraCrsGraph__SWIG_12") & -result(fresult) -use, intrinsic :: ISO_C_BINDING -import :: swigclasswrapper -import :: swigarraywrapper -type(SwigClassWrapper) :: farg1 -type(SwigClassWrapper) :: farg2 -type(SwigArrayWrapper) :: farg3 -type(SwigArrayWrapper) :: farg4 -type(SwigClassWrapper) :: farg5 -type(SwigClassWrapper) :: fresult -end function - -function swigc_new_TpetraCrsGraph__SWIG_13(farg1, farg2, farg3, farg4) & -bind(C, name="_wrap_new_TpetraCrsGraph__SWIG_13") & -result(fresult) -use, intrinsic :: ISO_C_BINDING -import :: swigclasswrapper -import :: swigarraywrapper -type(SwigClassWrapper) :: farg1 -type(SwigClassWrapper) :: farg2 -type(SwigArrayWrapper) :: farg3 -type(SwigArrayWrapper) :: farg4 -type(SwigClassWrapper) :: fresult -end function - subroutine swigc_TpetraCrsGraph_getNodeRowPtrs(farg1, farg2) & bind(C, name="_wrap_TpetraCrsGraph_getNodeRowPtrs") use, intrinsic :: ISO_C_BINDING @@ -3047,58 +3051,64 @@ function swigc_new_TpetraCrsMatrix__SWIG_2(farg1, farg2) & type(SwigClassWrapper) :: fresult end function -function swigc_new_TpetraCrsMatrix__SWIG_3(farg1, farg2, farg3, farg4, farg5) & +function swigc_new_TpetraCrsMatrix__SWIG_3(farg1, farg2, farg3, farg4) & bind(C, name="_wrap_new_TpetraCrsMatrix__SWIG_3") & result(fresult) use, intrinsic :: ISO_C_BINDING import :: swigclasswrapper +import :: swigarraywrapper type(SwigClassWrapper) :: farg1 -type(SwigClassWrapper) :: farg2 -integer(C_SIZE_T), intent(in) :: farg3 -integer(C_INT), intent(in) :: farg4 -type(SwigClassWrapper) :: farg5 +type(SwigArrayWrapper) :: farg2 +integer(C_INT), intent(in) :: farg3 +type(SwigClassWrapper) :: farg4 type(SwigClassWrapper) :: fresult end function -function swigc_new_TpetraCrsMatrix__SWIG_4(farg1, farg2, farg3, farg4) & +function swigc_new_TpetraCrsMatrix__SWIG_4(farg1, farg2, farg3) & bind(C, name="_wrap_new_TpetraCrsMatrix__SWIG_4") & result(fresult) use, intrinsic :: ISO_C_BINDING import :: swigclasswrapper +import :: swigarraywrapper type(SwigClassWrapper) :: farg1 -type(SwigClassWrapper) :: farg2 -integer(C_SIZE_T), intent(in) :: farg3 -integer(C_INT), intent(in) :: farg4 +type(SwigArrayWrapper) :: farg2 +integer(C_INT), intent(in) :: farg3 type(SwigClassWrapper) :: fresult end function -function swigc_new_TpetraCrsMatrix__SWIG_5(farg1, farg2, farg3) & +function swigc_new_TpetraCrsMatrix__SWIG_5(farg1, farg2) & bind(C, name="_wrap_new_TpetraCrsMatrix__SWIG_5") & result(fresult) use, intrinsic :: ISO_C_BINDING import :: swigclasswrapper +import :: swigarraywrapper type(SwigClassWrapper) :: farg1 -type(SwigClassWrapper) :: farg2 -integer(C_SIZE_T), intent(in) :: farg3 +type(SwigArrayWrapper) :: farg2 type(SwigClassWrapper) :: fresult end function -function swigc_new_TpetraCrsMatrix__SWIG_6(farg1, farg2) & +function swigc_new_TpetraCrsMatrix__SWIG_6(farg1, farg2, farg3, farg4, farg5) & bind(C, name="_wrap_new_TpetraCrsMatrix__SWIG_6") & result(fresult) use, intrinsic :: ISO_C_BINDING import :: swigclasswrapper type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 +integer(C_SIZE_T), intent(in) :: farg3 +integer(C_INT), intent(in) :: farg4 +type(SwigClassWrapper) :: farg5 type(SwigClassWrapper) :: fresult end function -function swigc_new_TpetraCrsMatrix__SWIG_7(farg1) & +function swigc_new_TpetraCrsMatrix__SWIG_7(farg1, farg2, farg3, farg4) & bind(C, name="_wrap_new_TpetraCrsMatrix__SWIG_7") & result(fresult) use, intrinsic :: ISO_C_BINDING import :: swigclasswrapper type(SwigClassWrapper) :: farg1 +type(SwigClassWrapper) :: farg2 +integer(C_SIZE_T), intent(in) :: farg3 +integer(C_INT), intent(in) :: farg4 type(SwigClassWrapper) :: fresult end function @@ -3109,36 +3119,134 @@ function swigc_new_TpetraCrsMatrix__SWIG_8(farg1, farg2, farg3) & import :: swigclasswrapper type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 -type(SwigClassWrapper) :: farg3 +integer(C_SIZE_T), intent(in) :: farg3 type(SwigClassWrapper) :: fresult end function -function swigc_new_TpetraCrsMatrix__SWIG_9(farg1, farg2) & +function swigc_new_TpetraCrsMatrix__SWIG_9(farg1, farg2, farg3, farg4, farg5) & bind(C, name="_wrap_new_TpetraCrsMatrix__SWIG_9") & result(fresult) use, intrinsic :: ISO_C_BINDING import :: swigclasswrapper +import :: swigarraywrapper type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 +type(SwigArrayWrapper) :: farg3 +integer(C_INT), intent(in) :: farg4 +type(SwigClassWrapper) :: farg5 type(SwigClassWrapper) :: fresult end function -subroutine swigc_delete_TpetraCrsMatrix(farg1) & -bind(C, name="_wrap_delete_TpetraCrsMatrix") +function swigc_new_TpetraCrsMatrix__SWIG_10(farg1, farg2, farg3, farg4) & +bind(C, name="_wrap_new_TpetraCrsMatrix__SWIG_10") & +result(fresult) use, intrinsic :: ISO_C_BINDING import :: swigclasswrapper +import :: swigarraywrapper type(SwigClassWrapper) :: farg1 -end subroutine +type(SwigClassWrapper) :: farg2 +type(SwigArrayWrapper) :: farg3 +integer(C_INT), intent(in) :: farg4 +type(SwigClassWrapper) :: fresult +end function -subroutine swigc_TpetraCrsMatrix_insertGlobalValues(farg1, farg2, farg3, farg4) & -bind(C, name="_wrap_TpetraCrsMatrix_insertGlobalValues") +function swigc_new_TpetraCrsMatrix__SWIG_11(farg1, farg2, farg3) & +bind(C, name="_wrap_new_TpetraCrsMatrix__SWIG_11") & +result(fresult) use, intrinsic :: ISO_C_BINDING import :: swigclasswrapper import :: swigarraywrapper type(SwigClassWrapper) :: farg1 -integer(C_LONG_LONG), intent(in) :: farg2 +type(SwigClassWrapper) :: farg2 type(SwigArrayWrapper) :: farg3 -type(SwigArrayWrapper) :: farg4 +type(SwigClassWrapper) :: fresult +end function + +function swigc_new_TpetraCrsMatrix__SWIG_12(farg1, farg2) & +bind(C, name="_wrap_new_TpetraCrsMatrix__SWIG_12") & +result(fresult) +use, intrinsic :: ISO_C_BINDING +import :: swigclasswrapper +type(SwigClassWrapper) :: farg1 +type(SwigClassWrapper) :: farg2 +type(SwigClassWrapper) :: fresult +end function + +function swigc_new_TpetraCrsMatrix__SWIG_13(farg1) & +bind(C, name="_wrap_new_TpetraCrsMatrix__SWIG_13") & +result(fresult) +use, intrinsic :: ISO_C_BINDING +import :: swigclasswrapper +type(SwigClassWrapper) :: farg1 +type(SwigClassWrapper) :: fresult +end function + +function swigc_new_TpetraCrsMatrix__SWIG_14(farg1, farg2, farg3) & +bind(C, name="_wrap_new_TpetraCrsMatrix__SWIG_14") & +result(fresult) +use, intrinsic :: ISO_C_BINDING +import :: swigclasswrapper +type(SwigClassWrapper) :: farg1 +type(SwigClassWrapper) :: farg2 +type(SwigClassWrapper) :: farg3 +type(SwigClassWrapper) :: fresult +end function + +function swigc_new_TpetraCrsMatrix__SWIG_15(farg1, farg2) & +bind(C, name="_wrap_new_TpetraCrsMatrix__SWIG_15") & +result(fresult) +use, intrinsic :: ISO_C_BINDING +import :: swigclasswrapper +type(SwigClassWrapper) :: farg1 +type(SwigClassWrapper) :: farg2 +type(SwigClassWrapper) :: fresult +end function + +function swigc_new_TpetraCrsMatrix__SWIG_16(farg1, farg2, farg3, farg4, farg5, farg6) & +bind(C, name="_wrap_new_TpetraCrsMatrix__SWIG_16") & +result(fresult) +use, intrinsic :: ISO_C_BINDING +import :: swigclasswrapper +import :: swigarraywrapper +type(SwigClassWrapper) :: farg1 +type(SwigClassWrapper) :: farg2 +type(SwigArrayWrapper) :: farg3 +type(SwigArrayWrapper) :: farg4 +type(SwigArrayWrapper) :: farg5 +type(SwigClassWrapper) :: farg6 +type(SwigClassWrapper) :: fresult +end function + +function swigc_new_TpetraCrsMatrix__SWIG_17(farg1, farg2, farg3, farg4, farg5) & +bind(C, name="_wrap_new_TpetraCrsMatrix__SWIG_17") & +result(fresult) +use, intrinsic :: ISO_C_BINDING +import :: swigclasswrapper +import :: swigarraywrapper +type(SwigClassWrapper) :: farg1 +type(SwigClassWrapper) :: farg2 +type(SwigArrayWrapper) :: farg3 +type(SwigArrayWrapper) :: farg4 +type(SwigArrayWrapper) :: farg5 +type(SwigClassWrapper) :: fresult +end function + +subroutine swigc_delete_TpetraCrsMatrix(farg1) & +bind(C, name="_wrap_delete_TpetraCrsMatrix") +use, intrinsic :: ISO_C_BINDING +import :: swigclasswrapper +type(SwigClassWrapper) :: farg1 +end subroutine + +subroutine swigc_TpetraCrsMatrix_insertGlobalValues(farg1, farg2, farg3, farg4) & +bind(C, name="_wrap_TpetraCrsMatrix_insertGlobalValues") +use, intrinsic :: ISO_C_BINDING +import :: swigclasswrapper +import :: swigarraywrapper +type(SwigClassWrapper) :: farg1 +integer(C_LONG_LONG), intent(in) :: farg2 +type(SwigArrayWrapper) :: farg3 +type(SwigArrayWrapper) :: farg4 end subroutine subroutine swigc_TpetraCrsMatrix_insertLocalValues(farg1, farg2, farg3, farg4) & @@ -3233,6 +3341,17 @@ subroutine swigc_TpetraCrsMatrix_scale(farg1, farg2) & real(C_DOUBLE), intent(in) :: farg2 end subroutine +subroutine swigc_TpetraCrsMatrix_setAllValues(farg1, farg2, farg3, farg4) & +bind(C, name="_wrap_TpetraCrsMatrix_setAllValues") +use, intrinsic :: ISO_C_BINDING +import :: swigclasswrapper +import :: swigarraywrapper +type(SwigClassWrapper) :: farg1 +type(SwigArrayWrapper) :: farg2 +type(SwigArrayWrapper) :: farg3 +type(SwigArrayWrapper) :: farg4 +end subroutine + subroutine swigc_TpetraCrsMatrix_globalAssemble(farg1) & bind(C, name="_wrap_TpetraCrsMatrix_globalAssemble") use, intrinsic :: ISO_C_BINDING @@ -3639,6 +3758,14 @@ subroutine swigc_TpetraCrsMatrix_getGlobalRowView(farg1, farg2, farg3, farg4) & type(SwigArrayWrapper) :: farg4 end subroutine +subroutine swigc_TpetraCrsMatrix_getLocalDiagOffsets(farg1, farg2) & +bind(C, name="_wrap_TpetraCrsMatrix_getLocalDiagOffsets") +use, intrinsic :: ISO_C_BINDING +import :: swigclasswrapper +type(SwigClassWrapper) :: farg1 +type(SwigClassWrapper) :: farg2 +end subroutine + subroutine swigc_TpetraCrsMatrix_apply__SWIG_0(farg1, farg2, farg3, farg4, farg5, farg6) & bind(C, name="_wrap_TpetraCrsMatrix_apply__SWIG_0") use, intrinsic :: ISO_C_BINDING @@ -3852,121 +3979,6 @@ function swigc_TpetraCrsMatrix_haveGlobalConstants(farg1) & integer(C_INT) :: fresult end function -function swigc_new_TpetraCrsMatrix__SWIG_10(farg1, farg2, farg3, farg4) & -bind(C, name="_wrap_new_TpetraCrsMatrix__SWIG_10") & -result(fresult) -use, intrinsic :: ISO_C_BINDING -import :: swigclasswrapper -import :: swigarraywrapper -type(SwigClassWrapper) :: farg1 -type(SwigArrayWrapper) :: farg2 -integer(C_INT), intent(in) :: farg3 -type(SwigClassWrapper) :: farg4 -type(SwigClassWrapper) :: fresult -end function - -function swigc_new_TpetraCrsMatrix__SWIG_11(farg1, farg2, farg3) & -bind(C, name="_wrap_new_TpetraCrsMatrix__SWIG_11") & -result(fresult) -use, intrinsic :: ISO_C_BINDING -import :: swigclasswrapper -import :: swigarraywrapper -type(SwigClassWrapper) :: farg1 -type(SwigArrayWrapper) :: farg2 -integer(C_INT), intent(in) :: farg3 -type(SwigClassWrapper) :: fresult -end function - -function swigc_new_TpetraCrsMatrix__SWIG_12(farg1, farg2) & -bind(C, name="_wrap_new_TpetraCrsMatrix__SWIG_12") & -result(fresult) -use, intrinsic :: ISO_C_BINDING -import :: swigclasswrapper -import :: swigarraywrapper -type(SwigClassWrapper) :: farg1 -type(SwigArrayWrapper) :: farg2 -type(SwigClassWrapper) :: fresult -end function - -function swigc_new_TpetraCrsMatrix__SWIG_13(farg1, farg2, farg3, farg4, farg5) & -bind(C, name="_wrap_new_TpetraCrsMatrix__SWIG_13") & -result(fresult) -use, intrinsic :: ISO_C_BINDING -import :: swigclasswrapper -import :: swigarraywrapper -type(SwigClassWrapper) :: farg1 -type(SwigClassWrapper) :: farg2 -type(SwigArrayWrapper) :: farg3 -integer(C_INT), intent(in) :: farg4 -type(SwigClassWrapper) :: farg5 -type(SwigClassWrapper) :: fresult -end function - -function swigc_new_TpetraCrsMatrix__SWIG_14(farg1, farg2, farg3, farg4) & -bind(C, name="_wrap_new_TpetraCrsMatrix__SWIG_14") & -result(fresult) -use, intrinsic :: ISO_C_BINDING -import :: swigclasswrapper -import :: swigarraywrapper -type(SwigClassWrapper) :: farg1 -type(SwigClassWrapper) :: farg2 -type(SwigArrayWrapper) :: farg3 -integer(C_INT), intent(in) :: farg4 -type(SwigClassWrapper) :: fresult -end function - -function swigc_new_TpetraCrsMatrix__SWIG_15(farg1, farg2, farg3) & -bind(C, name="_wrap_new_TpetraCrsMatrix__SWIG_15") & -result(fresult) -use, intrinsic :: ISO_C_BINDING -import :: swigclasswrapper -import :: swigarraywrapper -type(SwigClassWrapper) :: farg1 -type(SwigClassWrapper) :: farg2 -type(SwigArrayWrapper) :: farg3 -type(SwigClassWrapper) :: fresult -end function - -function swigc_new_TpetraCrsMatrix__SWIG_16(farg1, farg2, farg3, farg4, farg5, farg6) & -bind(C, name="_wrap_new_TpetraCrsMatrix__SWIG_16") & -result(fresult) -use, intrinsic :: ISO_C_BINDING -import :: swigclasswrapper -import :: swigarraywrapper -type(SwigClassWrapper) :: farg1 -type(SwigClassWrapper) :: farg2 -type(SwigArrayWrapper) :: farg3 -type(SwigArrayWrapper) :: farg4 -type(SwigArrayWrapper) :: farg5 -type(SwigClassWrapper) :: farg6 -type(SwigClassWrapper) :: fresult -end function - -function swigc_new_TpetraCrsMatrix__SWIG_17(farg1, farg2, farg3, farg4, farg5) & -bind(C, name="_wrap_new_TpetraCrsMatrix__SWIG_17") & -result(fresult) -use, intrinsic :: ISO_C_BINDING -import :: swigclasswrapper -import :: swigarraywrapper -type(SwigClassWrapper) :: farg1 -type(SwigClassWrapper) :: farg2 -type(SwigArrayWrapper) :: farg3 -type(SwigArrayWrapper) :: farg4 -type(SwigArrayWrapper) :: farg5 -type(SwigClassWrapper) :: fresult -end function - -subroutine swigc_TpetraCrsMatrix_setAllValues(farg1, farg2, farg3, farg4) & -bind(C, name="_wrap_TpetraCrsMatrix_setAllValues") -use, intrinsic :: ISO_C_BINDING -import :: swigclasswrapper -import :: swigarraywrapper -type(SwigClassWrapper) :: farg1 -type(SwigArrayWrapper) :: farg2 -type(SwigArrayWrapper) :: farg3 -type(SwigArrayWrapper) :: farg4 -end subroutine - subroutine swigc_TpetraCrsMatrix_getAllValues(farg1, farg2, farg3, farg4) & bind(C, name="_wrap_TpetraCrsMatrix_getAllValues") use, intrinsic :: ISO_C_BINDING @@ -7263,60 +7275,94 @@ function new_TpetraCrsGraph__SWIG_2(rowmap, maxnumentriesperrow) & self%swigdata = fresult end function -function new_TpetraCrsGraph__SWIG_3(rowmap, colmap, maxnumentriesperrow, pftype, params) & +function new_TpetraCrsGraph__SWIG_3(rowmap, numentperrow, pftype, params) & result(self) use, intrinsic :: ISO_C_BINDING type(TpetraCrsGraph) :: self class(TpetraMap), intent(in) :: rowmap -class(TpetraMap), intent(in) :: colmap - -integer(C_SIZE_T), intent(in) :: maxnumentriesperrow +integer(C_LONG), dimension(:), target :: numentperrow +integer(C_LONG), pointer :: farg2_view integer(TpetraProfileType), intent(in) :: pftype class(ParameterList), intent(in) :: params type(SwigClassWrapper) :: fresult type(SwigClassWrapper) :: farg1 -type(SwigClassWrapper) :: farg2 -integer(C_SIZE_T) :: farg3 -integer(C_INT) :: farg4 -type(SwigClassWrapper) :: farg5 +type(SwigArrayWrapper) :: farg2 +integer(C_INT) :: farg3 +type(SwigClassWrapper) :: farg4 farg1 = rowmap%swigdata -farg2 = colmap%swigdata -farg3 = maxnumentriesperrow -farg4 = pftype -farg5 = params%swigdata -fresult = swigc_new_TpetraCrsGraph__SWIG_3(farg1, farg2, farg3, farg4, farg5) +if (size(numentperrow) > 0) then +farg2_view => numentperrow(1) +farg2%data = c_loc(farg2_view) +farg2%size = size(numentperrow) +else +farg2%data = c_null_ptr +farg2%size = 0 +end if +farg3 = pftype +farg4 = params%swigdata +fresult = swigc_new_TpetraCrsGraph__SWIG_3(farg1, farg2, farg3, farg4) self%swigdata = fresult end function -function new_TpetraCrsGraph__SWIG_4(rowmap, colmap, maxnumentriesperrow, pftype) & +function new_TpetraCrsGraph__SWIG_4(rowmap, numentperrow, pftype) & result(self) use, intrinsic :: ISO_C_BINDING type(TpetraCrsGraph) :: self class(TpetraMap), intent(in) :: rowmap -class(TpetraMap), intent(in) :: colmap - -integer(C_SIZE_T), intent(in) :: maxnumentriesperrow +integer(C_LONG), dimension(:), target :: numentperrow +integer(C_LONG), pointer :: farg2_view integer(TpetraProfileType), intent(in) :: pftype type(SwigClassWrapper) :: fresult type(SwigClassWrapper) :: farg1 -type(SwigClassWrapper) :: farg2 -integer(C_SIZE_T) :: farg3 -integer(C_INT) :: farg4 +type(SwigArrayWrapper) :: farg2 +integer(C_INT) :: farg3 farg1 = rowmap%swigdata -farg2 = colmap%swigdata -farg3 = maxnumentriesperrow -farg4 = pftype -fresult = swigc_new_TpetraCrsGraph__SWIG_4(farg1, farg2, farg3, farg4) -self%swigdata = fresult -end function - -function new_TpetraCrsGraph__SWIG_5(rowmap, colmap, maxnumentriesperrow) & +if (size(numentperrow) > 0) then +farg2_view => numentperrow(1) +farg2%data = c_loc(farg2_view) +farg2%size = size(numentperrow) +else +farg2%data = c_null_ptr +farg2%size = 0 +end if +farg3 = pftype +fresult = swigc_new_TpetraCrsGraph__SWIG_4(farg1, farg2, farg3) +self%swigdata = fresult +end function + +function new_TpetraCrsGraph__SWIG_5(rowmap, numentperrow) & +result(self) +use, intrinsic :: ISO_C_BINDING +type(TpetraCrsGraph) :: self +class(TpetraMap), intent(in) :: rowmap + +integer(C_LONG), dimension(:), target :: numentperrow +integer(C_LONG), pointer :: farg2_view + +type(SwigClassWrapper) :: fresult +type(SwigClassWrapper) :: farg1 +type(SwigArrayWrapper) :: farg2 + +farg1 = rowmap%swigdata +if (size(numentperrow) > 0) then +farg2_view => numentperrow(1) +farg2%data = c_loc(farg2_view) +farg2%size = size(numentperrow) +else +farg2%data = c_null_ptr +farg2%size = 0 +end if +fresult = swigc_new_TpetraCrsGraph__SWIG_5(farg1, farg2) +self%swigdata = fresult +end function + +function new_TpetraCrsGraph__SWIG_6(rowmap, colmap, maxnumentriesperrow, pftype, params) & result(self) use, intrinsic :: ISO_C_BINDING type(TpetraCrsGraph) :: self @@ -7325,185 +7371,422 @@ function new_TpetraCrsGraph__SWIG_5(rowmap, colmap, maxnumentriesperrow) & class(TpetraMap), intent(in) :: colmap integer(C_SIZE_T), intent(in) :: maxnumentriesperrow +integer(TpetraProfileType), intent(in) :: pftype +class(ParameterList), intent(in) :: params type(SwigClassWrapper) :: fresult type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 integer(C_SIZE_T) :: farg3 +integer(C_INT) :: farg4 +type(SwigClassWrapper) :: farg5 farg1 = rowmap%swigdata farg2 = colmap%swigdata farg3 = maxnumentriesperrow -fresult = swigc_new_TpetraCrsGraph__SWIG_5(farg1, farg2, farg3) +farg4 = pftype +farg5 = params%swigdata +fresult = swigc_new_TpetraCrsGraph__SWIG_6(farg1, farg2, farg3, farg4, farg5) self%swigdata = fresult end function -subroutine delete_TpetraCrsGraph(self) +function new_TpetraCrsGraph__SWIG_7(rowmap, colmap, maxnumentriesperrow, pftype) & +result(self) use, intrinsic :: ISO_C_BINDING -class(TpetraCrsGraph), intent(inout) :: self - -type(SwigClassWrapper) :: farg1 - -farg1 = self%swigdata -if (self%swigdata%mem == SWIG_OWN) then -call swigc_delete_TpetraCrsGraph(farg1) -end if -self%swigdata%cptr = C_NULL_PTR -self%swigdata%mem = SWIG_NULL -end subroutine +type(TpetraCrsGraph) :: self +class(TpetraMap), intent(in) :: rowmap -subroutine swigf_TpetraCrsGraph_swap(self, graph) -use, intrinsic :: ISO_C_BINDING -class(TpetraCrsGraph), intent(inout) :: self +class(TpetraMap), intent(in) :: colmap -class(TpetraCrsGraph), intent(inout) :: graph +integer(C_SIZE_T), intent(in) :: maxnumentriesperrow +integer(TpetraProfileType), intent(in) :: pftype +type(SwigClassWrapper) :: fresult type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 +integer(C_SIZE_T) :: farg3 +integer(C_INT) :: farg4 -farg1 = self%swigdata -farg2 = graph%swigdata -call swigc_TpetraCrsGraph_swap(farg1, farg2) -end subroutine +farg1 = rowmap%swigdata +farg2 = colmap%swigdata +farg3 = maxnumentriesperrow +farg4 = pftype +fresult = swigc_new_TpetraCrsGraph__SWIG_7(farg1, farg2, farg3, farg4) +self%swigdata = fresult +end function -function swigf_TpetraCrsGraph_isIdenticalTo(self, graph) & -result(swig_result) +function new_TpetraCrsGraph__SWIG_8(rowmap, colmap, maxnumentriesperrow) & +result(self) use, intrinsic :: ISO_C_BINDING -logical :: swig_result -class(TpetraCrsGraph), intent(in) :: self +type(TpetraCrsGraph) :: self +class(TpetraMap), intent(in) :: rowmap -class(TpetraCrsGraph), intent(in) :: graph +class(TpetraMap), intent(in) :: colmap -integer(C_INT) :: fresult +integer(C_SIZE_T), intent(in) :: maxnumentriesperrow + +type(SwigClassWrapper) :: fresult type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 +integer(C_SIZE_T) :: farg3 -farg1 = self%swigdata -farg2 = graph%swigdata -fresult = swigc_TpetraCrsGraph_isIdenticalTo(farg1, farg2) -swig_result = SWIG_int_to_logical(fresult) +farg1 = rowmap%swigdata +farg2 = colmap%swigdata +farg3 = maxnumentriesperrow +fresult = swigc_new_TpetraCrsGraph__SWIG_8(farg1, farg2, farg3) +self%swigdata = fresult end function -subroutine swigf_TpetraCrsGraph_setParameterList(self, params) +function new_TpetraCrsGraph__SWIG_9(rowmap, colmap, numentperrow, pftype, params) & +result(self) use, intrinsic :: ISO_C_BINDING -class(TpetraCrsGraph), intent(inout) :: self - -class(ParameterList), intent(in) :: params - -type(SwigClassWrapper) :: farg1 -type(SwigClassWrapper) :: farg2 +type(TpetraCrsGraph) :: self +class(TpetraMap), intent(in) :: rowmap -farg1 = self%swigdata -farg2 = params%swigdata -call swigc_TpetraCrsGraph_setParameterList(farg1, farg2) -end subroutine +class(TpetraMap), intent(in) :: colmap -function swigf_TpetraCrsGraph_getValidParameters(self) & -result(swig_result) -use, intrinsic :: ISO_C_BINDING -type(ParameterList) :: swig_result -class(TpetraCrsGraph), intent(in) :: self +integer(C_LONG), dimension(:), target :: numentperrow +integer(C_LONG), pointer :: farg3_view +integer(TpetraProfileType), intent(in) :: pftype +class(ParameterList), intent(in) :: params type(SwigClassWrapper) :: fresult type(SwigClassWrapper) :: farg1 +type(SwigClassWrapper) :: farg2 +type(SwigArrayWrapper) :: farg3 +integer(C_INT) :: farg4 +type(SwigClassWrapper) :: farg5 -farg1 = self%swigdata -fresult = swigc_TpetraCrsGraph_getValidParameters(farg1) -swig_result%swigdata = fresult +farg1 = rowmap%swigdata +farg2 = colmap%swigdata +if (size(numentperrow) > 0) then +farg3_view => numentperrow(1) +farg3%data = c_loc(farg3_view) +farg3%size = size(numentperrow) +else +farg3%data = c_null_ptr +farg3%size = 0 +end if +farg4 = pftype +farg5 = params%swigdata +fresult = swigc_new_TpetraCrsGraph__SWIG_9(farg1, farg2, farg3, farg4, farg5) +self%swigdata = fresult end function -subroutine swigf_TpetraCrsGraph_insertGlobalIndices__SWIG_0(self, globalrow, indices) +function new_TpetraCrsGraph__SWIG_10(rowmap, colmap, numentperrow, pftype) & +result(self) use, intrinsic :: ISO_C_BINDING -class(TpetraCrsGraph), intent(inout) :: self +type(TpetraCrsGraph) :: self +class(TpetraMap), intent(in) :: rowmap -integer(C_LONG_LONG), intent(in) :: globalrow -integer(C_LONG_LONG), dimension(:), target :: indices -integer(C_LONG_LONG), pointer :: farg3_view +class(TpetraMap), intent(in) :: colmap + +integer(C_LONG), dimension(:), target :: numentperrow +integer(C_LONG), pointer :: farg3_view +integer(TpetraProfileType), intent(in) :: pftype +type(SwigClassWrapper) :: fresult type(SwigClassWrapper) :: farg1 -integer(C_LONG_LONG) :: farg2 +type(SwigClassWrapper) :: farg2 type(SwigArrayWrapper) :: farg3 +integer(C_INT) :: farg4 -farg1 = self%swigdata -farg2 = globalrow -if (size(indices) > 0) then -farg3_view => indices(1) +farg1 = rowmap%swigdata +farg2 = colmap%swigdata +if (size(numentperrow) > 0) then +farg3_view => numentperrow(1) farg3%data = c_loc(farg3_view) -farg3%size = size(indices) +farg3%size = size(numentperrow) else farg3%data = c_null_ptr farg3%size = 0 end if -call swigc_TpetraCrsGraph_insertGlobalIndices__SWIG_0(farg1, farg2, farg3) -end subroutine +farg4 = pftype +fresult = swigc_new_TpetraCrsGraph__SWIG_10(farg1, farg2, farg3, farg4) +self%swigdata = fresult +end function -subroutine swigf_TpetraCrsGraph_insertGlobalIndices__SWIG_1(self, globalrow, nument, inds) +function new_TpetraCrsGraph__SWIG_11(rowmap, colmap, numentperrow) & +result(self) use, intrinsic :: ISO_C_BINDING -class(TpetraCrsGraph), intent(inout) :: self - -integer(C_LONG_LONG), intent(in) :: globalrow -integer, intent(in) :: nument -integer(C_LONG_LONG), dimension(*), target, intent(in) :: inds - -type(SwigClassWrapper) :: farg1 -integer(C_LONG_LONG) :: farg2 -integer(C_INT) :: farg3 -type(C_PTR) :: farg4 - -farg1 = self%swigdata -farg2 = globalrow -farg3 = int(nument, C_INT) -farg4 = c_loc(inds(1)) -call swigc_TpetraCrsGraph_insertGlobalIndices__SWIG_1(farg1, farg2, farg3, farg4) -end subroutine +type(TpetraCrsGraph) :: self +class(TpetraMap), intent(in) :: rowmap -subroutine swigf_TpetraCrsGraph_insertLocalIndices(self, localrow, indices) -use, intrinsic :: ISO_C_BINDING -class(TpetraCrsGraph), intent(inout) :: self +class(TpetraMap), intent(in) :: colmap -integer, intent(in) :: localrow -integer(C_INT), dimension(:), target :: indices -integer(C_INT), pointer :: farg3_view +integer(C_LONG), dimension(:), target :: numentperrow +integer(C_LONG), pointer :: farg3_view +type(SwigClassWrapper) :: fresult type(SwigClassWrapper) :: farg1 -integer(C_INT) :: farg2 +type(SwigClassWrapper) :: farg2 type(SwigArrayWrapper) :: farg3 -farg1 = self%swigdata -farg2 = int(localrow, C_INT) -if (size(indices) > 0) then -farg3_view => indices(1) +farg1 = rowmap%swigdata +farg2 = colmap%swigdata +if (size(numentperrow) > 0) then +farg3_view => numentperrow(1) farg3%data = c_loc(farg3_view) -farg3%size = size(indices) +farg3%size = size(numentperrow) else farg3%data = c_null_ptr farg3%size = 0 end if -call swigc_TpetraCrsGraph_insertLocalIndices(farg1, farg2, farg3) -end subroutine +fresult = swigc_new_TpetraCrsGraph__SWIG_11(farg1, farg2, farg3) +self%swigdata = fresult +end function -subroutine swigf_TpetraCrsGraph_removeLocalIndices(self, localrow) +function new_TpetraCrsGraph__SWIG_12(rowmap, colmap, rowpointers, columnindices, params) & +result(self) use, intrinsic :: ISO_C_BINDING -class(TpetraCrsGraph), intent(inout) :: self - -integer, intent(in) :: localrow - -type(SwigClassWrapper) :: farg1 -integer(C_INT) :: farg2 +type(TpetraCrsGraph) :: self +class(TpetraMap), intent(in) :: rowmap -farg1 = self%swigdata -farg2 = int(localrow, C_INT) -call swigc_TpetraCrsGraph_removeLocalIndices(farg1, farg2) -end subroutine +class(TpetraMap), intent(in) :: colmap -subroutine swigf_TpetraCrsGraph_globalAssemble(self) -use, intrinsic :: ISO_C_BINDING -class(TpetraCrsGraph), intent(inout) :: self +integer(C_LONG), dimension(:), target :: rowpointers +integer(C_LONG), pointer :: farg3_view +integer(C_INT), dimension(:), target :: columnindices +integer(C_INT), pointer :: farg4_view +class(ParameterList), intent(in) :: params +type(SwigClassWrapper) :: fresult type(SwigClassWrapper) :: farg1 - -farg1 = self%swigdata -call swigc_TpetraCrsGraph_globalAssemble(farg1) +type(SwigClassWrapper) :: farg2 +type(SwigArrayWrapper) :: farg3 +type(SwigArrayWrapper) :: farg4 +type(SwigClassWrapper) :: farg5 + +farg1 = rowmap%swigdata +farg2 = colmap%swigdata +if (size(rowpointers) > 0) then +farg3_view => rowpointers(1) +farg3%data = c_loc(farg3_view) +farg3%size = size(rowpointers) +else +farg3%data = c_null_ptr +farg3%size = 0 +end if +if (size(columnindices) > 0) then +farg4_view => columnindices(1) +farg4%data = c_loc(farg4_view) +farg4%size = size(columnindices) +else +farg4%data = c_null_ptr +farg4%size = 0 +end if +farg5 = params%swigdata +fresult = swigc_new_TpetraCrsGraph__SWIG_12(farg1, farg2, farg3, farg4, farg5) +self%swigdata = fresult +end function + +function new_TpetraCrsGraph__SWIG_13(rowmap, colmap, rowpointers, columnindices) & +result(self) +use, intrinsic :: ISO_C_BINDING +type(TpetraCrsGraph) :: self +class(TpetraMap), intent(in) :: rowmap + +class(TpetraMap), intent(in) :: colmap + +integer(C_LONG), dimension(:), target :: rowpointers +integer(C_LONG), pointer :: farg3_view +integer(C_INT), dimension(:), target :: columnindices +integer(C_INT), pointer :: farg4_view + +type(SwigClassWrapper) :: fresult +type(SwigClassWrapper) :: farg1 +type(SwigClassWrapper) :: farg2 +type(SwigArrayWrapper) :: farg3 +type(SwigArrayWrapper) :: farg4 + +farg1 = rowmap%swigdata +farg2 = colmap%swigdata +if (size(rowpointers) > 0) then +farg3_view => rowpointers(1) +farg3%data = c_loc(farg3_view) +farg3%size = size(rowpointers) +else +farg3%data = c_null_ptr +farg3%size = 0 +end if +if (size(columnindices) > 0) then +farg4_view => columnindices(1) +farg4%data = c_loc(farg4_view) +farg4%size = size(columnindices) +else +farg4%data = c_null_ptr +farg4%size = 0 +end if +fresult = swigc_new_TpetraCrsGraph__SWIG_13(farg1, farg2, farg3, farg4) +self%swigdata = fresult +end function + +subroutine delete_TpetraCrsGraph(self) +use, intrinsic :: ISO_C_BINDING +class(TpetraCrsGraph), intent(inout) :: self + +type(SwigClassWrapper) :: farg1 + +farg1 = self%swigdata +if (self%swigdata%mem == SWIG_OWN) then +call swigc_delete_TpetraCrsGraph(farg1) +end if +self%swigdata%cptr = C_NULL_PTR +self%swigdata%mem = SWIG_NULL +end subroutine + +subroutine swigf_TpetraCrsGraph_swap(self, graph) +use, intrinsic :: ISO_C_BINDING +class(TpetraCrsGraph), intent(inout) :: self + +class(TpetraCrsGraph), intent(inout) :: graph + +type(SwigClassWrapper) :: farg1 +type(SwigClassWrapper) :: farg2 + +farg1 = self%swigdata +farg2 = graph%swigdata +call swigc_TpetraCrsGraph_swap(farg1, farg2) +end subroutine + +function swigf_TpetraCrsGraph_isIdenticalTo(self, graph) & +result(swig_result) +use, intrinsic :: ISO_C_BINDING +logical :: swig_result +class(TpetraCrsGraph), intent(in) :: self + +class(TpetraCrsGraph), intent(in) :: graph + +integer(C_INT) :: fresult +type(SwigClassWrapper) :: farg1 +type(SwigClassWrapper) :: farg2 + +farg1 = self%swigdata +farg2 = graph%swigdata +fresult = swigc_TpetraCrsGraph_isIdenticalTo(farg1, farg2) +swig_result = SWIG_int_to_logical(fresult) +end function + +subroutine swigf_TpetraCrsGraph_setParameterList(self, params) +use, intrinsic :: ISO_C_BINDING +class(TpetraCrsGraph), intent(inout) :: self + +class(ParameterList), intent(in) :: params + +type(SwigClassWrapper) :: farg1 +type(SwigClassWrapper) :: farg2 + +farg1 = self%swigdata +farg2 = params%swigdata +call swigc_TpetraCrsGraph_setParameterList(farg1, farg2) +end subroutine + +function swigf_TpetraCrsGraph_getValidParameters(self) & +result(swig_result) +use, intrinsic :: ISO_C_BINDING +type(ParameterList) :: swig_result +class(TpetraCrsGraph), intent(in) :: self + +type(SwigClassWrapper) :: fresult +type(SwigClassWrapper) :: farg1 + +farg1 = self%swigdata +fresult = swigc_TpetraCrsGraph_getValidParameters(farg1) +swig_result%swigdata = fresult +end function + +subroutine swigf_TpetraCrsGraph_insertGlobalIndices__SWIG_0(self, globalrow, indices) +use, intrinsic :: ISO_C_BINDING +class(TpetraCrsGraph), intent(inout) :: self + +integer(C_LONG_LONG), intent(in) :: globalrow +integer(C_LONG_LONG), dimension(:), target :: indices +integer(C_LONG_LONG), pointer :: farg3_view + +type(SwigClassWrapper) :: farg1 +integer(C_LONG_LONG) :: farg2 +type(SwigArrayWrapper) :: farg3 + +farg1 = self%swigdata +farg2 = globalrow +if (size(indices) > 0) then +farg3_view => indices(1) +farg3%data = c_loc(farg3_view) +farg3%size = size(indices) +else +farg3%data = c_null_ptr +farg3%size = 0 +end if +call swigc_TpetraCrsGraph_insertGlobalIndices__SWIG_0(farg1, farg2, farg3) +end subroutine + +subroutine swigf_TpetraCrsGraph_insertGlobalIndices__SWIG_1(self, globalrow, nument, inds) +use, intrinsic :: ISO_C_BINDING +class(TpetraCrsGraph), intent(inout) :: self + +integer(C_LONG_LONG), intent(in) :: globalrow +integer, intent(in) :: nument +integer(C_LONG_LONG), dimension(*), target, intent(in) :: inds + +type(SwigClassWrapper) :: farg1 +integer(C_LONG_LONG) :: farg2 +integer(C_INT) :: farg3 +type(C_PTR) :: farg4 + +farg1 = self%swigdata +farg2 = globalrow +farg3 = int(nument, C_INT) +farg4 = c_loc(inds(1)) +call swigc_TpetraCrsGraph_insertGlobalIndices__SWIG_1(farg1, farg2, farg3, farg4) +end subroutine + +subroutine swigf_TpetraCrsGraph_insertLocalIndices(self, localrow, indices) +use, intrinsic :: ISO_C_BINDING +class(TpetraCrsGraph), intent(inout) :: self + +integer, intent(in) :: localrow +integer(C_INT), dimension(:), target :: indices +integer(C_INT), pointer :: farg3_view + +type(SwigClassWrapper) :: farg1 +integer(C_INT) :: farg2 +type(SwigArrayWrapper) :: farg3 + +farg1 = self%swigdata +farg2 = int(localrow, C_INT) +if (size(indices) > 0) then +farg3_view => indices(1) +farg3%data = c_loc(farg3_view) +farg3%size = size(indices) +else +farg3%data = c_null_ptr +farg3%size = 0 +end if +call swigc_TpetraCrsGraph_insertLocalIndices(farg1, farg2, farg3) +end subroutine + +subroutine swigf_TpetraCrsGraph_removeLocalIndices(self, localrow) +use, intrinsic :: ISO_C_BINDING +class(TpetraCrsGraph), intent(inout) :: self + +integer, intent(in) :: localrow + +type(SwigClassWrapper) :: farg1 +integer(C_INT) :: farg2 + +farg1 = self%swigdata +farg2 = int(localrow, C_INT) +call swigc_TpetraCrsGraph_removeLocalIndices(farg1, farg2) +end subroutine + +subroutine swigf_TpetraCrsGraph_globalAssemble(self) +use, intrinsic :: ISO_C_BINDING +class(TpetraCrsGraph), intent(inout) :: self + +type(SwigClassWrapper) :: farg1 + +farg1 = self%swigdata +call swigc_TpetraCrsGraph_globalAssemble(farg1) end subroutine subroutine swigf_TpetraCrsGraph_resumeFill__SWIG_0(self, params) @@ -8533,196 +8816,544 @@ subroutine swigf_TpetraCrsGraph_computeGlobalConstants(self, computelocaltriangu call swigc_TpetraCrsGraph_computeGlobalConstants(farg1, farg2) end subroutine -function new_TpetraCrsGraph__SWIG_6(rowmap, numentperrow, pftype, params) & -result(self) +subroutine swigf_TpetraCrsGraph_getNodeRowPtrs(self, rowpointers) use, intrinsic :: ISO_C_BINDING -type(TpetraCrsGraph) :: self -class(TpetraMap), intent(in) :: rowmap +class(TpetraCrsGraph), intent(in) :: self -integer(C_LONG), dimension(:), target :: numentperrow +integer(C_LONG), dimension(:), target :: rowpointers integer(C_LONG), pointer :: farg2_view -integer(TpetraProfileType), intent(in) :: pftype -class(ParameterList), intent(in) :: params -type(SwigClassWrapper) :: fresult type(SwigClassWrapper) :: farg1 type(SwigArrayWrapper) :: farg2 -integer(C_INT) :: farg3 -type(SwigClassWrapper) :: farg4 -farg1 = rowmap%swigdata -if (size(numentperrow) > 0) then -farg2_view => numentperrow(1) +farg1 = self%swigdata +if (size(rowpointers) > 0) then +farg2_view => rowpointers(1) farg2%data = c_loc(farg2_view) -farg2%size = size(numentperrow) +farg2%size = size(rowpointers) else farg2%data = c_null_ptr farg2%size = 0 end if -farg3 = pftype +call swigc_TpetraCrsGraph_getNodeRowPtrs(farg1, farg2) +end subroutine + +subroutine swigf_TpetraCrsGraph_getNodePackedIndices(self, columnindices) +use, intrinsic :: ISO_C_BINDING +class(TpetraCrsGraph), intent(in) :: self + +integer(C_LONG), dimension(:), target :: columnindices +integer(C_LONG), pointer :: farg2_view + +type(SwigClassWrapper) :: farg1 +type(SwigArrayWrapper) :: farg2 + +farg1 = self%swigdata +if (size(columnindices) > 0) then +farg2_view => columnindices(1) +farg2%data = c_loc(farg2_view) +farg2%size = size(columnindices) +else +farg2%data = c_null_ptr +farg2%size = 0 +end if +call swigc_TpetraCrsGraph_getNodePackedIndices(farg1, farg2) +end subroutine + +subroutine swigf_TpetraCrsGraph_doImport__SWIG_0(self, source, importer, cm) +use, intrinsic :: ISO_C_BINDING +class(TpetraCrsGraph), intent(inout) :: self + +class(TpetraCrsGraph), intent(in) :: source + +class(TpetraImport), intent(in) :: importer + +integer(TpetraCombineMode), intent(in) :: cm + +type(SwigClassWrapper) :: farg1 +type(SwigClassWrapper) :: farg2 +type(SwigClassWrapper) :: farg3 +integer(C_INT) :: farg4 + +farg1 = self%swigdata +farg2 = source%swigdata +farg3 = importer%swigdata +farg4 = cm +call swigc_TpetraCrsGraph_doImport__SWIG_0(farg1, farg2, farg3, farg4) +end subroutine + +subroutine swigf_TpetraCrsGraph_doImport__SWIG_1(self, source, exporter, cm) +use, intrinsic :: ISO_C_BINDING +class(TpetraCrsGraph), intent(inout) :: self + +class(TpetraCrsGraph), intent(in) :: source + +class(TpetraExport), intent(in) :: exporter + +integer(TpetraCombineMode), intent(in) :: cm + +type(SwigClassWrapper) :: farg1 +type(SwigClassWrapper) :: farg2 +type(SwigClassWrapper) :: farg3 +integer(C_INT) :: farg4 + +farg1 = self%swigdata +farg2 = source%swigdata +farg3 = exporter%swigdata +farg4 = cm +call swigc_TpetraCrsGraph_doImport__SWIG_1(farg1, farg2, farg3, farg4) +end subroutine + +subroutine swigf_TpetraCrsGraph_doExport__SWIG_0(self, source, exporter, cm) +use, intrinsic :: ISO_C_BINDING +class(TpetraCrsGraph), intent(inout) :: self + +class(TpetraCrsGraph), intent(in) :: source + +class(TpetraExport), intent(in) :: exporter + +integer(TpetraCombineMode), intent(in) :: cm + +type(SwigClassWrapper) :: farg1 +type(SwigClassWrapper) :: farg2 +type(SwigClassWrapper) :: farg3 +integer(C_INT) :: farg4 + +farg1 = self%swigdata +farg2 = source%swigdata +farg3 = exporter%swigdata +farg4 = cm +call swigc_TpetraCrsGraph_doExport__SWIG_0(farg1, farg2, farg3, farg4) +end subroutine + +subroutine swigf_TpetraCrsGraph_doExport__SWIG_1(self, source, importer, cm) +use, intrinsic :: ISO_C_BINDING +class(TpetraCrsGraph), intent(inout) :: self + +class(TpetraCrsGraph), intent(in) :: source + +class(TpetraImport), intent(in) :: importer + +integer(TpetraCombineMode), intent(in) :: cm + +type(SwigClassWrapper) :: farg1 +type(SwigClassWrapper) :: farg2 +type(SwigClassWrapper) :: farg3 +integer(C_INT) :: farg4 + +farg1 = self%swigdata +farg2 = source%swigdata +farg3 = importer%swigdata +farg4 = cm +call swigc_TpetraCrsGraph_doExport__SWIG_1(farg1, farg2, farg3, farg4) +end subroutine + + subroutine swigf_assignment_TpetraCrsGraph(self, other) + use, intrinsic :: ISO_C_BINDING + class(TpetraCrsGraph), intent(inout) :: self + type(TpetraCrsGraph), intent(in) :: other + call swigc_assignment_TpetraCrsGraph(self%swigdata, other%swigdata) + end subroutine +function new_TpetraCrsMatrix__SWIG_0(rowmap, maxnumentriesperrow, pftype, params) & +result(self) +use, intrinsic :: ISO_C_BINDING +type(TpetraCrsMatrix) :: self +class(TpetraMap), intent(in) :: rowmap + +integer(C_SIZE_T), intent(in) :: maxnumentriesperrow +integer(TpetraProfileType), intent(in) :: pftype +class(ParameterList), intent(in) :: params + +type(SwigClassWrapper) :: fresult +type(SwigClassWrapper) :: farg1 +integer(C_SIZE_T) :: farg2 +integer(C_INT) :: farg3 +type(SwigClassWrapper) :: farg4 + +farg1 = rowmap%swigdata +farg2 = maxnumentriesperrow +farg3 = pftype farg4 = params%swigdata -fresult = swigc_new_TpetraCrsGraph__SWIG_6(farg1, farg2, farg3, farg4) +fresult = swigc_new_TpetraCrsMatrix__SWIG_0(farg1, farg2, farg3, farg4) self%swigdata = fresult end function -function new_TpetraCrsGraph__SWIG_7(rowmap, numentperrow, pftype) & +function new_TpetraCrsMatrix__SWIG_1(rowmap, maxnumentriesperrow, pftype) & result(self) use, intrinsic :: ISO_C_BINDING -type(TpetraCrsGraph) :: self +type(TpetraCrsMatrix) :: self class(TpetraMap), intent(in) :: rowmap -integer(C_LONG), dimension(:), target :: numentperrow +integer(C_SIZE_T), intent(in) :: maxnumentriesperrow +integer(TpetraProfileType), intent(in) :: pftype + +type(SwigClassWrapper) :: fresult +type(SwigClassWrapper) :: farg1 +integer(C_SIZE_T) :: farg2 +integer(C_INT) :: farg3 + +farg1 = rowmap%swigdata +farg2 = maxnumentriesperrow +farg3 = pftype +fresult = swigc_new_TpetraCrsMatrix__SWIG_1(farg1, farg2, farg3) +self%swigdata = fresult +end function + +function new_TpetraCrsMatrix__SWIG_2(rowmap, maxnumentriesperrow) & +result(self) +use, intrinsic :: ISO_C_BINDING +type(TpetraCrsMatrix) :: self +class(TpetraMap), intent(in) :: rowmap + +integer(C_SIZE_T), intent(in) :: maxnumentriesperrow + +type(SwigClassWrapper) :: fresult +type(SwigClassWrapper) :: farg1 +integer(C_SIZE_T) :: farg2 + +farg1 = rowmap%swigdata +farg2 = maxnumentriesperrow +fresult = swigc_new_TpetraCrsMatrix__SWIG_2(farg1, farg2) +self%swigdata = fresult +end function + +function new_TpetraCrsMatrix__SWIG_3(rowmap, numentriesperrowtoalloc, pftype, params) & +result(self) +use, intrinsic :: ISO_C_BINDING +type(TpetraCrsMatrix) :: self +class(TpetraMap), intent(in) :: rowmap + +integer(C_LONG), dimension(:), target :: numentriesperrowtoalloc integer(C_LONG), pointer :: farg2_view integer(TpetraProfileType), intent(in) :: pftype +class(ParameterList), intent(in) :: params type(SwigClassWrapper) :: fresult type(SwigClassWrapper) :: farg1 type(SwigArrayWrapper) :: farg2 integer(C_INT) :: farg3 +type(SwigClassWrapper) :: farg4 farg1 = rowmap%swigdata -if (size(numentperrow) > 0) then -farg2_view => numentperrow(1) +if (size(numentriesperrowtoalloc) > 0) then +farg2_view => numentriesperrowtoalloc(1) farg2%data = c_loc(farg2_view) -farg2%size = size(numentperrow) +farg2%size = size(numentriesperrowtoalloc) else farg2%data = c_null_ptr farg2%size = 0 end if farg3 = pftype -fresult = swigc_new_TpetraCrsGraph__SWIG_7(farg1, farg2, farg3) +farg4 = params%swigdata +fresult = swigc_new_TpetraCrsMatrix__SWIG_3(farg1, farg2, farg3, farg4) self%swigdata = fresult end function -function new_TpetraCrsGraph__SWIG_8(rowmap, numentperrow) & +function new_TpetraCrsMatrix__SWIG_4(rowmap, numentriesperrowtoalloc, pftype) & result(self) use, intrinsic :: ISO_C_BINDING -type(TpetraCrsGraph) :: self +type(TpetraCrsMatrix) :: self class(TpetraMap), intent(in) :: rowmap -integer(C_LONG), dimension(:), target :: numentperrow +integer(C_LONG), dimension(:), target :: numentriesperrowtoalloc integer(C_LONG), pointer :: farg2_view +integer(TpetraProfileType), intent(in) :: pftype type(SwigClassWrapper) :: fresult type(SwigClassWrapper) :: farg1 type(SwigArrayWrapper) :: farg2 +integer(C_INT) :: farg3 farg1 = rowmap%swigdata -if (size(numentperrow) > 0) then -farg2_view => numentperrow(1) +if (size(numentriesperrowtoalloc) > 0) then +farg2_view => numentriesperrowtoalloc(1) farg2%data = c_loc(farg2_view) -farg2%size = size(numentperrow) +farg2%size = size(numentriesperrowtoalloc) else farg2%data = c_null_ptr farg2%size = 0 end if -fresult = swigc_new_TpetraCrsGraph__SWIG_8(farg1, farg2) +farg3 = pftype +fresult = swigc_new_TpetraCrsMatrix__SWIG_4(farg1, farg2, farg3) self%swigdata = fresult end function -function new_TpetraCrsGraph__SWIG_9(rowmap, colmap, numentperrow, pftype, params) & +function new_TpetraCrsMatrix__SWIG_5(rowmap, numentriesperrowtoalloc) & result(self) use, intrinsic :: ISO_C_BINDING -type(TpetraCrsGraph) :: self +type(TpetraCrsMatrix) :: self +class(TpetraMap), intent(in) :: rowmap + +integer(C_LONG), dimension(:), target :: numentriesperrowtoalloc +integer(C_LONG), pointer :: farg2_view + +type(SwigClassWrapper) :: fresult +type(SwigClassWrapper) :: farg1 +type(SwigArrayWrapper) :: farg2 + +farg1 = rowmap%swigdata +if (size(numentriesperrowtoalloc) > 0) then +farg2_view => numentriesperrowtoalloc(1) +farg2%data = c_loc(farg2_view) +farg2%size = size(numentriesperrowtoalloc) +else +farg2%data = c_null_ptr +farg2%size = 0 +end if +fresult = swigc_new_TpetraCrsMatrix__SWIG_5(farg1, farg2) +self%swigdata = fresult +end function + +function new_TpetraCrsMatrix__SWIG_6(rowmap, colmap, maxnumentriesperrow, pftype, params) & +result(self) +use, intrinsic :: ISO_C_BINDING +type(TpetraCrsMatrix) :: self class(TpetraMap), intent(in) :: rowmap class(TpetraMap), intent(in) :: colmap -integer(C_LONG), dimension(:), target :: numentperrow -integer(C_LONG), pointer :: farg3_view +integer(C_SIZE_T), intent(in) :: maxnumentriesperrow integer(TpetraProfileType), intent(in) :: pftype class(ParameterList), intent(in) :: params type(SwigClassWrapper) :: fresult type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 -type(SwigArrayWrapper) :: farg3 +integer(C_SIZE_T) :: farg3 integer(C_INT) :: farg4 type(SwigClassWrapper) :: farg5 farg1 = rowmap%swigdata farg2 = colmap%swigdata -if (size(numentperrow) > 0) then -farg3_view => numentperrow(1) -farg3%data = c_loc(farg3_view) -farg3%size = size(numentperrow) -else -farg3%data = c_null_ptr -farg3%size = 0 -end if +farg3 = maxnumentriesperrow farg4 = pftype farg5 = params%swigdata -fresult = swigc_new_TpetraCrsGraph__SWIG_9(farg1, farg2, farg3, farg4, farg5) +fresult = swigc_new_TpetraCrsMatrix__SWIG_6(farg1, farg2, farg3, farg4, farg5) self%swigdata = fresult end function -function new_TpetraCrsGraph__SWIG_10(rowmap, colmap, numentperrow, pftype) & +function new_TpetraCrsMatrix__SWIG_7(rowmap, colmap, maxnumentriesperrow, pftype) & result(self) use, intrinsic :: ISO_C_BINDING -type(TpetraCrsGraph) :: self +type(TpetraCrsMatrix) :: self class(TpetraMap), intent(in) :: rowmap class(TpetraMap), intent(in) :: colmap -integer(C_LONG), dimension(:), target :: numentperrow -integer(C_LONG), pointer :: farg3_view +integer(C_SIZE_T), intent(in) :: maxnumentriesperrow integer(TpetraProfileType), intent(in) :: pftype type(SwigClassWrapper) :: fresult type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 -type(SwigArrayWrapper) :: farg3 +integer(C_SIZE_T) :: farg3 integer(C_INT) :: farg4 farg1 = rowmap%swigdata farg2 = colmap%swigdata -if (size(numentperrow) > 0) then -farg3_view => numentperrow(1) +farg3 = maxnumentriesperrow +farg4 = pftype +fresult = swigc_new_TpetraCrsMatrix__SWIG_7(farg1, farg2, farg3, farg4) +self%swigdata = fresult +end function + +function new_TpetraCrsMatrix__SWIG_8(rowmap, colmap, maxnumentriesperrow) & +result(self) +use, intrinsic :: ISO_C_BINDING +type(TpetraCrsMatrix) :: self +class(TpetraMap), intent(in) :: rowmap + +class(TpetraMap), intent(in) :: colmap + +integer(C_SIZE_T), intent(in) :: maxnumentriesperrow + +type(SwigClassWrapper) :: fresult +type(SwigClassWrapper) :: farg1 +type(SwigClassWrapper) :: farg2 +integer(C_SIZE_T) :: farg3 + +farg1 = rowmap%swigdata +farg2 = colmap%swigdata +farg3 = maxnumentriesperrow +fresult = swigc_new_TpetraCrsMatrix__SWIG_8(farg1, farg2, farg3) +self%swigdata = fresult +end function + +function new_TpetraCrsMatrix__SWIG_9(rowmap, colmap, numentriesperrowtoalloc, pftype, params) & +result(self) +use, intrinsic :: ISO_C_BINDING +type(TpetraCrsMatrix) :: self +class(TpetraMap), intent(in) :: rowmap + +class(TpetraMap), intent(in) :: colmap + +integer(C_LONG), dimension(:), target :: numentriesperrowtoalloc +integer(C_LONG), pointer :: farg3_view +integer(TpetraProfileType), intent(in) :: pftype +class(ParameterList), intent(in) :: params + +type(SwigClassWrapper) :: fresult +type(SwigClassWrapper) :: farg1 +type(SwigClassWrapper) :: farg2 +type(SwigArrayWrapper) :: farg3 +integer(C_INT) :: farg4 +type(SwigClassWrapper) :: farg5 + +farg1 = rowmap%swigdata +farg2 = colmap%swigdata +if (size(numentriesperrowtoalloc) > 0) then +farg3_view => numentriesperrowtoalloc(1) farg3%data = c_loc(farg3_view) -farg3%size = size(numentperrow) +farg3%size = size(numentriesperrowtoalloc) else farg3%data = c_null_ptr farg3%size = 0 end if farg4 = pftype -fresult = swigc_new_TpetraCrsGraph__SWIG_10(farg1, farg2, farg3, farg4) +farg5 = params%swigdata +fresult = swigc_new_TpetraCrsMatrix__SWIG_9(farg1, farg2, farg3, farg4, farg5) self%swigdata = fresult end function -function new_TpetraCrsGraph__SWIG_11(rowmap, colmap, numentperrow) & +function new_TpetraCrsMatrix__SWIG_10(rowmap, colmap, numentriesperrowtoalloc, pftype) & result(self) use, intrinsic :: ISO_C_BINDING -type(TpetraCrsGraph) :: self +type(TpetraCrsMatrix) :: self class(TpetraMap), intent(in) :: rowmap class(TpetraMap), intent(in) :: colmap -integer(C_LONG), dimension(:), target :: numentperrow +integer(C_LONG), dimension(:), target :: numentriesperrowtoalloc integer(C_LONG), pointer :: farg3_view +integer(TpetraProfileType), intent(in) :: pftype type(SwigClassWrapper) :: fresult type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 type(SwigArrayWrapper) :: farg3 +integer(C_INT) :: farg4 farg1 = rowmap%swigdata farg2 = colmap%swigdata -if (size(numentperrow) > 0) then -farg3_view => numentperrow(1) +if (size(numentriesperrowtoalloc) > 0) then +farg3_view => numentriesperrowtoalloc(1) farg3%data = c_loc(farg3_view) -farg3%size = size(numentperrow) +farg3%size = size(numentriesperrowtoalloc) else farg3%data = c_null_ptr farg3%size = 0 end if -fresult = swigc_new_TpetraCrsGraph__SWIG_11(farg1, farg2, farg3) +farg4 = pftype +fresult = swigc_new_TpetraCrsMatrix__SWIG_10(farg1, farg2, farg3, farg4) self%swigdata = fresult end function -function new_TpetraCrsGraph__SWIG_12(rowmap, colmap, rowpointers, columnindices, params) & +function new_TpetraCrsMatrix__SWIG_11(rowmap, colmap, numentriesperrowtoalloc) & result(self) use, intrinsic :: ISO_C_BINDING -type(TpetraCrsGraph) :: self +type(TpetraCrsMatrix) :: self +class(TpetraMap), intent(in) :: rowmap + +class(TpetraMap), intent(in) :: colmap + +integer(C_LONG), dimension(:), target :: numentriesperrowtoalloc +integer(C_LONG), pointer :: farg3_view + +type(SwigClassWrapper) :: fresult +type(SwigClassWrapper) :: farg1 +type(SwigClassWrapper) :: farg2 +type(SwigArrayWrapper) :: farg3 + +farg1 = rowmap%swigdata +farg2 = colmap%swigdata +if (size(numentriesperrowtoalloc) > 0) then +farg3_view => numentriesperrowtoalloc(1) +farg3%data = c_loc(farg3_view) +farg3%size = size(numentriesperrowtoalloc) +else +farg3%data = c_null_ptr +farg3%size = 0 +end if +fresult = swigc_new_TpetraCrsMatrix__SWIG_11(farg1, farg2, farg3) +self%swigdata = fresult +end function + +function new_TpetraCrsMatrix__SWIG_12(graph, params) & +result(self) +use, intrinsic :: ISO_C_BINDING +type(TpetraCrsMatrix) :: self +class(TpetraCrsGraph), intent(in) :: graph + +class(ParameterList), intent(in) :: params + +type(SwigClassWrapper) :: fresult +type(SwigClassWrapper) :: farg1 +type(SwigClassWrapper) :: farg2 + +farg1 = graph%swigdata +farg2 = params%swigdata +fresult = swigc_new_TpetraCrsMatrix__SWIG_12(farg1, farg2) +self%swigdata = fresult +end function + +function new_TpetraCrsMatrix__SWIG_13(graph) & +result(self) +use, intrinsic :: ISO_C_BINDING +type(TpetraCrsMatrix) :: self +class(TpetraCrsGraph), intent(in) :: graph + +type(SwigClassWrapper) :: fresult +type(SwigClassWrapper) :: farg1 + +farg1 = graph%swigdata +fresult = swigc_new_TpetraCrsMatrix__SWIG_13(farg1) +self%swigdata = fresult +end function + +function new_TpetraCrsMatrix__SWIG_14(graph, values, params) & +result(self) +use, intrinsic :: ISO_C_BINDING +type(TpetraCrsMatrix) :: self +class(TpetraCrsGraph), intent(in) :: graph + +class(SWIGTYPE_KokkosSparse__CrsMatrixT_Tpetra__CrsMatrixT_doub1E12GN), intent(in) :: values + +class(ParameterList), intent(in) :: params + +type(SwigClassWrapper) :: fresult +type(SwigClassWrapper) :: farg1 +type(SwigClassWrapper) :: farg2 +type(SwigClassWrapper) :: farg3 + +farg1 = graph%swigdata +farg2 = values%swigdata +farg3 = params%swigdata +fresult = swigc_new_TpetraCrsMatrix__SWIG_14(farg1, farg2, farg3) +self%swigdata = fresult +end function + +function new_TpetraCrsMatrix__SWIG_15(graph, values) & +result(self) +use, intrinsic :: ISO_C_BINDING +type(TpetraCrsMatrix) :: self +class(TpetraCrsGraph), intent(in) :: graph + +class(SWIGTYPE_KokkosSparse__CrsMatrixT_Tpetra__CrsMatrixT_doub1E12GN), intent(in) :: values + +type(SwigClassWrapper) :: fresult +type(SwigClassWrapper) :: farg1 +type(SwigClassWrapper) :: farg2 + +farg1 = graph%swigdata +farg2 = values%swigdata +fresult = swigc_new_TpetraCrsMatrix__SWIG_15(farg1, farg2) +self%swigdata = fresult +end function + +function new_TpetraCrsMatrix__SWIG_16(rowmap, colmap, rowpointers, columnindices, values, params) & +result(self) +use, intrinsic :: ISO_C_BINDING +type(TpetraCrsMatrix) :: self class(TpetraMap), intent(in) :: rowmap class(TpetraMap), intent(in) :: colmap @@ -8731,6 +9362,8 @@ function new_TpetraCrsGraph__SWIG_12(rowmap, colmap, rowpointers, columnindices, integer(C_LONG), pointer :: farg3_view integer(C_INT), dimension(:), target :: columnindices integer(C_INT), pointer :: farg4_view +real(C_DOUBLE), dimension(:), target :: values +real(C_DOUBLE), pointer :: farg5_view class(ParameterList), intent(in) :: params type(SwigClassWrapper) :: fresult @@ -8738,7 +9371,8 @@ function new_TpetraCrsGraph__SWIG_12(rowmap, colmap, rowpointers, columnindices, type(SwigClassWrapper) :: farg2 type(SwigArrayWrapper) :: farg3 type(SwigArrayWrapper) :: farg4 -type(SwigClassWrapper) :: farg5 +type(SwigArrayWrapper) :: farg5 +type(SwigClassWrapper) :: farg6 farg1 = rowmap%swigdata farg2 = colmap%swigdata @@ -8758,15 +9392,23 @@ function new_TpetraCrsGraph__SWIG_12(rowmap, colmap, rowpointers, columnindices, farg4%data = c_null_ptr farg4%size = 0 end if -farg5 = params%swigdata -fresult = swigc_new_TpetraCrsGraph__SWIG_12(farg1, farg2, farg3, farg4, farg5) +if (size(values) > 0) then +farg5_view => values(1) +farg5%data = c_loc(farg5_view) +farg5%size = size(values) +else +farg5%data = c_null_ptr +farg5%size = 0 +end if +farg6 = params%swigdata +fresult = swigc_new_TpetraCrsMatrix__SWIG_16(farg1, farg2, farg3, farg4, farg5, farg6) self%swigdata = fresult end function -function new_TpetraCrsGraph__SWIG_13(rowmap, colmap, rowpointers, columnindices) & +function new_TpetraCrsMatrix__SWIG_17(rowmap, colmap, rowpointers, columnindices, values) & result(self) use, intrinsic :: ISO_C_BINDING -type(TpetraCrsGraph) :: self +type(TpetraCrsMatrix) :: self class(TpetraMap), intent(in) :: rowmap class(TpetraMap), intent(in) :: colmap @@ -8775,12 +9417,15 @@ function new_TpetraCrsGraph__SWIG_13(rowmap, colmap, rowpointers, columnindices) integer(C_LONG), pointer :: farg3_view integer(C_INT), dimension(:), target :: columnindices integer(C_INT), pointer :: farg4_view +real(C_DOUBLE), dimension(:), target :: values +real(C_DOUBLE), pointer :: farg5_view type(SwigClassWrapper) :: fresult type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 type(SwigArrayWrapper) :: farg3 type(SwigArrayWrapper) :: farg4 +type(SwigArrayWrapper) :: farg5 farg1 = rowmap%swigdata farg2 = colmap%swigdata @@ -8800,396 +9445,56 @@ function new_TpetraCrsGraph__SWIG_13(rowmap, colmap, rowpointers, columnindices) farg4%data = c_null_ptr farg4%size = 0 end if -fresult = swigc_new_TpetraCrsGraph__SWIG_13(farg1, farg2, farg3, farg4) +if (size(values) > 0) then +farg5_view => values(1) +farg5%data = c_loc(farg5_view) +farg5%size = size(values) +else +farg5%data = c_null_ptr +farg5%size = 0 +end if +fresult = swigc_new_TpetraCrsMatrix__SWIG_17(farg1, farg2, farg3, farg4, farg5) self%swigdata = fresult end function -subroutine swigf_TpetraCrsGraph_getNodeRowPtrs(self, rowpointers) +subroutine delete_TpetraCrsMatrix(self) use, intrinsic :: ISO_C_BINDING -class(TpetraCrsGraph), intent(in) :: self - -integer(C_LONG), dimension(:), target :: rowpointers -integer(C_LONG), pointer :: farg2_view +class(TpetraCrsMatrix), intent(inout) :: self type(SwigClassWrapper) :: farg1 -type(SwigArrayWrapper) :: farg2 farg1 = self%swigdata -if (size(rowpointers) > 0) then -farg2_view => rowpointers(1) -farg2%data = c_loc(farg2_view) -farg2%size = size(rowpointers) -else -farg2%data = c_null_ptr -farg2%size = 0 +if (self%swigdata%mem == SWIG_OWN) then +call swigc_delete_TpetraCrsMatrix(farg1) end if -call swigc_TpetraCrsGraph_getNodeRowPtrs(farg1, farg2) +self%swigdata%cptr = C_NULL_PTR +self%swigdata%mem = SWIG_NULL end subroutine -subroutine swigf_TpetraCrsGraph_getNodePackedIndices(self, columnindices) +subroutine swigf_TpetraCrsMatrix_insertGlobalValues(self, globalrow, cols, vals) use, intrinsic :: ISO_C_BINDING -class(TpetraCrsGraph), intent(in) :: self +class(TpetraCrsMatrix), intent(inout) :: self -integer(C_LONG), dimension(:), target :: columnindices -integer(C_LONG), pointer :: farg2_view +integer(C_LONG_LONG), intent(in) :: globalrow +integer(C_LONG_LONG), dimension(:), target :: cols +integer(C_LONG_LONG), pointer :: farg3_view +real(C_DOUBLE), dimension(:), target :: vals +real(C_DOUBLE), pointer :: farg4_view type(SwigClassWrapper) :: farg1 -type(SwigArrayWrapper) :: farg2 +integer(C_LONG_LONG) :: farg2 +type(SwigArrayWrapper) :: farg3 +type(SwigArrayWrapper) :: farg4 farg1 = self%swigdata -if (size(columnindices) > 0) then -farg2_view => columnindices(1) -farg2%data = c_loc(farg2_view) -farg2%size = size(columnindices) +farg2 = globalrow +if (size(cols) > 0) then +farg3_view => cols(1) +farg3%data = c_loc(farg3_view) +farg3%size = size(cols) else -farg2%data = c_null_ptr -farg2%size = 0 -end if -call swigc_TpetraCrsGraph_getNodePackedIndices(farg1, farg2) -end subroutine - -subroutine swigf_TpetraCrsGraph_doImport__SWIG_0(self, source, importer, cm) -use, intrinsic :: ISO_C_BINDING -class(TpetraCrsGraph), intent(inout) :: self - -class(TpetraCrsGraph), intent(in) :: source - -class(TpetraImport), intent(in) :: importer - -integer(TpetraCombineMode), intent(in) :: cm - -type(SwigClassWrapper) :: farg1 -type(SwigClassWrapper) :: farg2 -type(SwigClassWrapper) :: farg3 -integer(C_INT) :: farg4 - -farg1 = self%swigdata -farg2 = source%swigdata -farg3 = importer%swigdata -farg4 = cm -call swigc_TpetraCrsGraph_doImport__SWIG_0(farg1, farg2, farg3, farg4) -end subroutine - -subroutine swigf_TpetraCrsGraph_doImport__SWIG_1(self, source, exporter, cm) -use, intrinsic :: ISO_C_BINDING -class(TpetraCrsGraph), intent(inout) :: self - -class(TpetraCrsGraph), intent(in) :: source - -class(TpetraExport), intent(in) :: exporter - -integer(TpetraCombineMode), intent(in) :: cm - -type(SwigClassWrapper) :: farg1 -type(SwigClassWrapper) :: farg2 -type(SwigClassWrapper) :: farg3 -integer(C_INT) :: farg4 - -farg1 = self%swigdata -farg2 = source%swigdata -farg3 = exporter%swigdata -farg4 = cm -call swigc_TpetraCrsGraph_doImport__SWIG_1(farg1, farg2, farg3, farg4) -end subroutine - -subroutine swigf_TpetraCrsGraph_doExport__SWIG_0(self, source, exporter, cm) -use, intrinsic :: ISO_C_BINDING -class(TpetraCrsGraph), intent(inout) :: self - -class(TpetraCrsGraph), intent(in) :: source - -class(TpetraExport), intent(in) :: exporter - -integer(TpetraCombineMode), intent(in) :: cm - -type(SwigClassWrapper) :: farg1 -type(SwigClassWrapper) :: farg2 -type(SwigClassWrapper) :: farg3 -integer(C_INT) :: farg4 - -farg1 = self%swigdata -farg2 = source%swigdata -farg3 = exporter%swigdata -farg4 = cm -call swigc_TpetraCrsGraph_doExport__SWIG_0(farg1, farg2, farg3, farg4) -end subroutine - -subroutine swigf_TpetraCrsGraph_doExport__SWIG_1(self, source, importer, cm) -use, intrinsic :: ISO_C_BINDING -class(TpetraCrsGraph), intent(inout) :: self - -class(TpetraCrsGraph), intent(in) :: source - -class(TpetraImport), intent(in) :: importer - -integer(TpetraCombineMode), intent(in) :: cm - -type(SwigClassWrapper) :: farg1 -type(SwigClassWrapper) :: farg2 -type(SwigClassWrapper) :: farg3 -integer(C_INT) :: farg4 - -farg1 = self%swigdata -farg2 = source%swigdata -farg3 = importer%swigdata -farg4 = cm -call swigc_TpetraCrsGraph_doExport__SWIG_1(farg1, farg2, farg3, farg4) -end subroutine - - subroutine swigf_assignment_TpetraCrsGraph(self, other) - use, intrinsic :: ISO_C_BINDING - class(TpetraCrsGraph), intent(inout) :: self - type(TpetraCrsGraph), intent(in) :: other - call swigc_assignment_TpetraCrsGraph(self%swigdata, other%swigdata) - end subroutine -function new_TpetraCrsMatrix__SWIG_0(rowmap, maxnumentriesperrow, pftype, params) & -result(self) -use, intrinsic :: ISO_C_BINDING -type(TpetraCrsMatrix) :: self -class(TpetraMap), intent(in) :: rowmap - -integer(C_SIZE_T), intent(in) :: maxnumentriesperrow -integer(TpetraProfileType), intent(in) :: pftype -class(ParameterList), intent(in) :: params - -type(SwigClassWrapper) :: fresult -type(SwigClassWrapper) :: farg1 -integer(C_SIZE_T) :: farg2 -integer(C_INT) :: farg3 -type(SwigClassWrapper) :: farg4 - -farg1 = rowmap%swigdata -farg2 = maxnumentriesperrow -farg3 = pftype -farg4 = params%swigdata -fresult = swigc_new_TpetraCrsMatrix__SWIG_0(farg1, farg2, farg3, farg4) -self%swigdata = fresult -end function - -function new_TpetraCrsMatrix__SWIG_1(rowmap, maxnumentriesperrow, pftype) & -result(self) -use, intrinsic :: ISO_C_BINDING -type(TpetraCrsMatrix) :: self -class(TpetraMap), intent(in) :: rowmap - -integer(C_SIZE_T), intent(in) :: maxnumentriesperrow -integer(TpetraProfileType), intent(in) :: pftype - -type(SwigClassWrapper) :: fresult -type(SwigClassWrapper) :: farg1 -integer(C_SIZE_T) :: farg2 -integer(C_INT) :: farg3 - -farg1 = rowmap%swigdata -farg2 = maxnumentriesperrow -farg3 = pftype -fresult = swigc_new_TpetraCrsMatrix__SWIG_1(farg1, farg2, farg3) -self%swigdata = fresult -end function - -function new_TpetraCrsMatrix__SWIG_2(rowmap, maxnumentriesperrow) & -result(self) -use, intrinsic :: ISO_C_BINDING -type(TpetraCrsMatrix) :: self -class(TpetraMap), intent(in) :: rowmap - -integer(C_SIZE_T), intent(in) :: maxnumentriesperrow - -type(SwigClassWrapper) :: fresult -type(SwigClassWrapper) :: farg1 -integer(C_SIZE_T) :: farg2 - -farg1 = rowmap%swigdata -farg2 = maxnumentriesperrow -fresult = swigc_new_TpetraCrsMatrix__SWIG_2(farg1, farg2) -self%swigdata = fresult -end function - -function new_TpetraCrsMatrix__SWIG_3(rowmap, colmap, maxnumentriesperrow, pftype, params) & -result(self) -use, intrinsic :: ISO_C_BINDING -type(TpetraCrsMatrix) :: self -class(TpetraMap), intent(in) :: rowmap - -class(TpetraMap), intent(in) :: colmap - -integer(C_SIZE_T), intent(in) :: maxnumentriesperrow -integer(TpetraProfileType), intent(in) :: pftype -class(ParameterList), intent(in) :: params - -type(SwigClassWrapper) :: fresult -type(SwigClassWrapper) :: farg1 -type(SwigClassWrapper) :: farg2 -integer(C_SIZE_T) :: farg3 -integer(C_INT) :: farg4 -type(SwigClassWrapper) :: farg5 - -farg1 = rowmap%swigdata -farg2 = colmap%swigdata -farg3 = maxnumentriesperrow -farg4 = pftype -farg5 = params%swigdata -fresult = swigc_new_TpetraCrsMatrix__SWIG_3(farg1, farg2, farg3, farg4, farg5) -self%swigdata = fresult -end function - -function new_TpetraCrsMatrix__SWIG_4(rowmap, colmap, maxnumentriesperrow, pftype) & -result(self) -use, intrinsic :: ISO_C_BINDING -type(TpetraCrsMatrix) :: self -class(TpetraMap), intent(in) :: rowmap - -class(TpetraMap), intent(in) :: colmap - -integer(C_SIZE_T), intent(in) :: maxnumentriesperrow -integer(TpetraProfileType), intent(in) :: pftype - -type(SwigClassWrapper) :: fresult -type(SwigClassWrapper) :: farg1 -type(SwigClassWrapper) :: farg2 -integer(C_SIZE_T) :: farg3 -integer(C_INT) :: farg4 - -farg1 = rowmap%swigdata -farg2 = colmap%swigdata -farg3 = maxnumentriesperrow -farg4 = pftype -fresult = swigc_new_TpetraCrsMatrix__SWIG_4(farg1, farg2, farg3, farg4) -self%swigdata = fresult -end function - -function new_TpetraCrsMatrix__SWIG_5(rowmap, colmap, maxnumentriesperrow) & -result(self) -use, intrinsic :: ISO_C_BINDING -type(TpetraCrsMatrix) :: self -class(TpetraMap), intent(in) :: rowmap - -class(TpetraMap), intent(in) :: colmap - -integer(C_SIZE_T), intent(in) :: maxnumentriesperrow - -type(SwigClassWrapper) :: fresult -type(SwigClassWrapper) :: farg1 -type(SwigClassWrapper) :: farg2 -integer(C_SIZE_T) :: farg3 - -farg1 = rowmap%swigdata -farg2 = colmap%swigdata -farg3 = maxnumentriesperrow -fresult = swigc_new_TpetraCrsMatrix__SWIG_5(farg1, farg2, farg3) -self%swigdata = fresult -end function - -function new_TpetraCrsMatrix__SWIG_6(graph, params) & -result(self) -use, intrinsic :: ISO_C_BINDING -type(TpetraCrsMatrix) :: self -class(TpetraCrsGraph), intent(in) :: graph - -class(ParameterList), intent(in) :: params - -type(SwigClassWrapper) :: fresult -type(SwigClassWrapper) :: farg1 -type(SwigClassWrapper) :: farg2 - -farg1 = graph%swigdata -farg2 = params%swigdata -fresult = swigc_new_TpetraCrsMatrix__SWIG_6(farg1, farg2) -self%swigdata = fresult -end function - -function new_TpetraCrsMatrix__SWIG_7(graph) & -result(self) -use, intrinsic :: ISO_C_BINDING -type(TpetraCrsMatrix) :: self -class(TpetraCrsGraph), intent(in) :: graph - -type(SwigClassWrapper) :: fresult -type(SwigClassWrapper) :: farg1 - -farg1 = graph%swigdata -fresult = swigc_new_TpetraCrsMatrix__SWIG_7(farg1) -self%swigdata = fresult -end function - -function new_TpetraCrsMatrix__SWIG_8(graph, values, params) & -result(self) -use, intrinsic :: ISO_C_BINDING -type(TpetraCrsMatrix) :: self -class(TpetraCrsGraph), intent(in) :: graph - -class(SWIGTYPE_KokkosSparse__CrsMatrixT_Tpetra__CrsMatrixT_doub1E12GN), intent(in) :: values - -class(ParameterList), intent(in) :: params - -type(SwigClassWrapper) :: fresult -type(SwigClassWrapper) :: farg1 -type(SwigClassWrapper) :: farg2 -type(SwigClassWrapper) :: farg3 - -farg1 = graph%swigdata -farg2 = values%swigdata -farg3 = params%swigdata -fresult = swigc_new_TpetraCrsMatrix__SWIG_8(farg1, farg2, farg3) -self%swigdata = fresult -end function - -function new_TpetraCrsMatrix__SWIG_9(graph, values) & -result(self) -use, intrinsic :: ISO_C_BINDING -type(TpetraCrsMatrix) :: self -class(TpetraCrsGraph), intent(in) :: graph - -class(SWIGTYPE_KokkosSparse__CrsMatrixT_Tpetra__CrsMatrixT_doub1E12GN), intent(in) :: values - -type(SwigClassWrapper) :: fresult -type(SwigClassWrapper) :: farg1 -type(SwigClassWrapper) :: farg2 - -farg1 = graph%swigdata -farg2 = values%swigdata -fresult = swigc_new_TpetraCrsMatrix__SWIG_9(farg1, farg2) -self%swigdata = fresult -end function - -subroutine delete_TpetraCrsMatrix(self) -use, intrinsic :: ISO_C_BINDING -class(TpetraCrsMatrix), intent(inout) :: self - -type(SwigClassWrapper) :: farg1 - -farg1 = self%swigdata -if (self%swigdata%mem == SWIG_OWN) then -call swigc_delete_TpetraCrsMatrix(farg1) -end if -self%swigdata%cptr = C_NULL_PTR -self%swigdata%mem = SWIG_NULL -end subroutine - -subroutine swigf_TpetraCrsMatrix_insertGlobalValues(self, globalrow, cols, vals) -use, intrinsic :: ISO_C_BINDING -class(TpetraCrsMatrix), intent(inout) :: self - -integer(C_LONG_LONG), intent(in) :: globalrow -integer(C_LONG_LONG), dimension(:), target :: cols -integer(C_LONG_LONG), pointer :: farg3_view -real(C_DOUBLE), dimension(:), target :: vals -real(C_DOUBLE), pointer :: farg4_view - -type(SwigClassWrapper) :: farg1 -integer(C_LONG_LONG) :: farg2 -type(SwigArrayWrapper) :: farg3 -type(SwigArrayWrapper) :: farg4 - -farg1 = self%swigdata -farg2 = globalrow -if (size(cols) > 0) then -farg3_view => cols(1) -farg3%data = c_loc(farg3_view) -farg3%size = size(cols) -else -farg3%data = c_null_ptr -farg3%size = 0 +farg3%data = c_null_ptr +farg3%size = 0 end if if (size(vals) > 0) then farg4_view => vals(1) @@ -9453,6 +9758,50 @@ subroutine swigf_TpetraCrsMatrix_scale(self, alpha) call swigc_TpetraCrsMatrix_scale(farg1, farg2) end subroutine +subroutine swigf_TpetraCrsMatrix_setAllValues(self, ptr, ind, val) +use, intrinsic :: ISO_C_BINDING +class(TpetraCrsMatrix), intent(inout) :: self + +integer(C_LONG), dimension(:), target :: ptr +integer(C_LONG), pointer :: farg2_view +integer(C_INT), dimension(:), target :: ind +integer(C_INT), pointer :: farg3_view +real(C_DOUBLE), dimension(:), target :: val +real(C_DOUBLE), pointer :: farg4_view + +type(SwigClassWrapper) :: farg1 +type(SwigArrayWrapper) :: farg2 +type(SwigArrayWrapper) :: farg3 +type(SwigArrayWrapper) :: farg4 + +farg1 = self%swigdata +if (size(ptr) > 0) then +farg2_view => ptr(1) +farg2%data = c_loc(farg2_view) +farg2%size = size(ptr) +else +farg2%data = c_null_ptr +farg2%size = 0 +end if +if (size(ind) > 0) then +farg3_view => ind(1) +farg3%data = c_loc(farg3_view) +farg3%size = size(ind) +else +farg3%data = c_null_ptr +farg3%size = 0 +end if +if (size(val) > 0) then +farg4_view => val(1) +farg4%data = c_loc(farg4_view) +farg4%size = size(val) +else +farg4%data = c_null_ptr +farg4%size = 0 +end if +call swigc_TpetraCrsMatrix_setAllValues(farg1, farg2, farg3, farg4) +end subroutine + subroutine swigf_TpetraCrsMatrix_globalAssemble(self) use, intrinsic :: ISO_C_BINDING class(TpetraCrsMatrix), intent(inout) :: self @@ -10223,6 +10572,20 @@ subroutine swigf_TpetraCrsMatrix_getGlobalRowView(self, globalrow, indices, valu endif end subroutine +subroutine swigf_TpetraCrsMatrix_getLocalDiagOffsets(self, offsets) +use, intrinsic :: ISO_C_BINDING +class(TpetraCrsMatrix), intent(in) :: self + +class(SWIGTYPE_Teuchos__ArrayRCPT_unsigned_long_t), intent(inout) :: offsets + +type(SwigClassWrapper) :: farg1 +type(SwigClassWrapper) :: farg2 + +farg1 = self%swigdata +farg2 = offsets%swigdata +call swigc_TpetraCrsMatrix_getLocalDiagOffsets(farg1, farg2) +end subroutine + subroutine swigf_TpetraCrsMatrix_apply__SWIG_0(self, x, y, mode, alpha, beta) use, intrinsic :: ISO_C_BINDING class(TpetraCrsMatrix), intent(in) :: self @@ -10559,470 +10922,133 @@ subroutine swigf_TpetraCrsMatrix_exportAndFillComplete__SWIG_0(self, destmatrix, farg5 = rangemap%swigdata farg6 = params%swigdata call swigc_TpetraCrsMatrix_exportAndFillComplete__SWIG_0(farg1, farg2, farg3, farg4, farg5, farg6) -end subroutine - -subroutine swigf_TpetraCrsMatrix_exportAndFillComplete__SWIG_1(self, destmatrix, exporter, domainmap, rangemap) -use, intrinsic :: ISO_C_BINDING -class(TpetraCrsMatrix), intent(in) :: self - -class(TpetraCrsMatrix), intent(inout) :: destmatrix - -class(TpetraExport), intent(in) :: exporter - -class(TpetraMap), intent(in) :: domainmap - -class(TpetraMap), intent(in) :: rangemap - -type(SwigClassWrapper) :: farg1 -type(SwigClassWrapper) :: farg2 -type(SwigClassWrapper) :: farg3 -type(SwigClassWrapper) :: farg4 -type(SwigClassWrapper) :: farg5 - -farg1 = self%swigdata -farg2 = destmatrix%swigdata -farg3 = exporter%swigdata -farg4 = domainmap%swigdata -farg5 = rangemap%swigdata -call swigc_TpetraCrsMatrix_exportAndFillComplete__SWIG_1(farg1, farg2, farg3, farg4, farg5) -end subroutine - -subroutine swigf_TpetraCrsMatrix_exportAndFillComplete__SWIG_2(self, destmatrix, exporter, domainmap) -use, intrinsic :: ISO_C_BINDING -class(TpetraCrsMatrix), intent(in) :: self - -class(TpetraCrsMatrix), intent(inout) :: destmatrix - -class(TpetraExport), intent(in) :: exporter - -class(TpetraMap), intent(in) :: domainmap - -type(SwigClassWrapper) :: farg1 -type(SwigClassWrapper) :: farg2 -type(SwigClassWrapper) :: farg3 -type(SwigClassWrapper) :: farg4 - -farg1 = self%swigdata -farg2 = destmatrix%swigdata -farg3 = exporter%swigdata -farg4 = domainmap%swigdata -call swigc_TpetraCrsMatrix_exportAndFillComplete__SWIG_2(farg1, farg2, farg3, farg4) -end subroutine - -subroutine swigf_TpetraCrsMatrix_exportAndFillComplete__SWIG_3(self, destmatrix, exporter) -use, intrinsic :: ISO_C_BINDING -class(TpetraCrsMatrix), intent(in) :: self - -class(TpetraCrsMatrix), intent(inout) :: destmatrix - -class(TpetraExport), intent(in) :: exporter - -type(SwigClassWrapper) :: farg1 -type(SwigClassWrapper) :: farg2 -type(SwigClassWrapper) :: farg3 - -farg1 = self%swigdata -farg2 = destmatrix%swigdata -farg3 = exporter%swigdata -call swigc_TpetraCrsMatrix_exportAndFillComplete__SWIG_3(farg1, farg2, farg3) -end subroutine - -subroutine swigf_TpetraCrsMatrix_exportAndFillComplete__SWIG_4(self, destmatrix, rowexporter, domainexporter, domainmap, & - rangemap, params) -use, intrinsic :: ISO_C_BINDING -class(TpetraCrsMatrix), intent(in) :: self - -class(TpetraCrsMatrix), intent(inout) :: destmatrix - -class(TpetraExport), intent(in) :: rowexporter - -class(TpetraExport), intent(in) :: domainexporter - -class(TpetraMap), intent(in) :: domainmap - -class(TpetraMap), intent(in) :: rangemap - -class(ParameterList), intent(in) :: params - -type(SwigClassWrapper) :: farg1 -type(SwigClassWrapper) :: farg2 -type(SwigClassWrapper) :: farg3 -type(SwigClassWrapper) :: farg4 -type(SwigClassWrapper) :: farg5 -type(SwigClassWrapper) :: farg6 -type(SwigClassWrapper) :: farg7 - -farg1 = self%swigdata -farg2 = destmatrix%swigdata -farg3 = rowexporter%swigdata -farg4 = domainexporter%swigdata -farg5 = domainmap%swigdata -farg6 = rangemap%swigdata -farg7 = params%swigdata -call swigc_TpetraCrsMatrix_exportAndFillComplete__SWIG_4(farg1, farg2, farg3, farg4, farg5, farg6, farg7) -end subroutine - -subroutine swigf_TpetraCrsMatrix_computeGlobalConstants(self) -use, intrinsic :: ISO_C_BINDING -class(TpetraCrsMatrix), intent(inout) :: self - -type(SwigClassWrapper) :: farg1 - -farg1 = self%swigdata -call swigc_TpetraCrsMatrix_computeGlobalConstants(farg1) -end subroutine - -function swigf_TpetraCrsMatrix_haveGlobalConstants(self) & -result(swig_result) -use, intrinsic :: ISO_C_BINDING -logical :: swig_result -class(TpetraCrsMatrix), intent(in) :: self - -integer(C_INT) :: fresult -type(SwigClassWrapper) :: farg1 - -farg1 = self%swigdata -fresult = swigc_TpetraCrsMatrix_haveGlobalConstants(farg1) -swig_result = SWIG_int_to_logical(fresult) -end function - -function new_TpetraCrsMatrix__SWIG_10(rowmap, numentriesperrowtoalloc, pftype, params) & -result(self) -use, intrinsic :: ISO_C_BINDING -type(TpetraCrsMatrix) :: self -class(TpetraMap), intent(in) :: rowmap - -integer(C_LONG), dimension(:), target :: numentriesperrowtoalloc -integer(C_LONG), pointer :: farg2_view -integer(TpetraProfileType), intent(in) :: pftype -class(ParameterList), intent(in) :: params - -type(SwigClassWrapper) :: fresult -type(SwigClassWrapper) :: farg1 -type(SwigArrayWrapper) :: farg2 -integer(C_INT) :: farg3 -type(SwigClassWrapper) :: farg4 - -farg1 = rowmap%swigdata -if (size(numentriesperrowtoalloc) > 0) then -farg2_view => numentriesperrowtoalloc(1) -farg2%data = c_loc(farg2_view) -farg2%size = size(numentriesperrowtoalloc) -else -farg2%data = c_null_ptr -farg2%size = 0 -end if -farg3 = pftype -farg4 = params%swigdata -fresult = swigc_new_TpetraCrsMatrix__SWIG_10(farg1, farg2, farg3, farg4) -self%swigdata = fresult -end function - -function new_TpetraCrsMatrix__SWIG_11(rowmap, numentriesperrowtoalloc, pftype) & -result(self) -use, intrinsic :: ISO_C_BINDING -type(TpetraCrsMatrix) :: self -class(TpetraMap), intent(in) :: rowmap - -integer(C_LONG), dimension(:), target :: numentriesperrowtoalloc -integer(C_LONG), pointer :: farg2_view -integer(TpetraProfileType), intent(in) :: pftype - -type(SwigClassWrapper) :: fresult -type(SwigClassWrapper) :: farg1 -type(SwigArrayWrapper) :: farg2 -integer(C_INT) :: farg3 - -farg1 = rowmap%swigdata -if (size(numentriesperrowtoalloc) > 0) then -farg2_view => numentriesperrowtoalloc(1) -farg2%data = c_loc(farg2_view) -farg2%size = size(numentriesperrowtoalloc) -else -farg2%data = c_null_ptr -farg2%size = 0 -end if -farg3 = pftype -fresult = swigc_new_TpetraCrsMatrix__SWIG_11(farg1, farg2, farg3) -self%swigdata = fresult -end function - -function new_TpetraCrsMatrix__SWIG_12(rowmap, numentriesperrowtoalloc) & -result(self) -use, intrinsic :: ISO_C_BINDING -type(TpetraCrsMatrix) :: self -class(TpetraMap), intent(in) :: rowmap - -integer(C_LONG), dimension(:), target :: numentriesperrowtoalloc -integer(C_LONG), pointer :: farg2_view - -type(SwigClassWrapper) :: fresult -type(SwigClassWrapper) :: farg1 -type(SwigArrayWrapper) :: farg2 - -farg1 = rowmap%swigdata -if (size(numentriesperrowtoalloc) > 0) then -farg2_view => numentriesperrowtoalloc(1) -farg2%data = c_loc(farg2_view) -farg2%size = size(numentriesperrowtoalloc) -else -farg2%data = c_null_ptr -farg2%size = 0 -end if -fresult = swigc_new_TpetraCrsMatrix__SWIG_12(farg1, farg2) -self%swigdata = fresult -end function - -function new_TpetraCrsMatrix__SWIG_13(rowmap, colmap, numentriesperrowtoalloc, pftype, params) & -result(self) -use, intrinsic :: ISO_C_BINDING -type(TpetraCrsMatrix) :: self -class(TpetraMap), intent(in) :: rowmap - -class(TpetraMap), intent(in) :: colmap - -integer(C_LONG), dimension(:), target :: numentriesperrowtoalloc -integer(C_LONG), pointer :: farg3_view -integer(TpetraProfileType), intent(in) :: pftype -class(ParameterList), intent(in) :: params - -type(SwigClassWrapper) :: fresult -type(SwigClassWrapper) :: farg1 -type(SwigClassWrapper) :: farg2 -type(SwigArrayWrapper) :: farg3 -integer(C_INT) :: farg4 -type(SwigClassWrapper) :: farg5 - -farg1 = rowmap%swigdata -farg2 = colmap%swigdata -if (size(numentriesperrowtoalloc) > 0) then -farg3_view => numentriesperrowtoalloc(1) -farg3%data = c_loc(farg3_view) -farg3%size = size(numentriesperrowtoalloc) -else -farg3%data = c_null_ptr -farg3%size = 0 -end if -farg4 = pftype -farg5 = params%swigdata -fresult = swigc_new_TpetraCrsMatrix__SWIG_13(farg1, farg2, farg3, farg4, farg5) -self%swigdata = fresult -end function +end subroutine -function new_TpetraCrsMatrix__SWIG_14(rowmap, colmap, numentriesperrowtoalloc, pftype) & -result(self) +subroutine swigf_TpetraCrsMatrix_exportAndFillComplete__SWIG_1(self, destmatrix, exporter, domainmap, rangemap) use, intrinsic :: ISO_C_BINDING -type(TpetraCrsMatrix) :: self -class(TpetraMap), intent(in) :: rowmap +class(TpetraCrsMatrix), intent(in) :: self -class(TpetraMap), intent(in) :: colmap +class(TpetraCrsMatrix), intent(inout) :: destmatrix -integer(C_LONG), dimension(:), target :: numentriesperrowtoalloc -integer(C_LONG), pointer :: farg3_view -integer(TpetraProfileType), intent(in) :: pftype +class(TpetraExport), intent(in) :: exporter + +class(TpetraMap), intent(in) :: domainmap + +class(TpetraMap), intent(in) :: rangemap -type(SwigClassWrapper) :: fresult type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 -type(SwigArrayWrapper) :: farg3 -integer(C_INT) :: farg4 +type(SwigClassWrapper) :: farg3 +type(SwigClassWrapper) :: farg4 +type(SwigClassWrapper) :: farg5 -farg1 = rowmap%swigdata -farg2 = colmap%swigdata -if (size(numentriesperrowtoalloc) > 0) then -farg3_view => numentriesperrowtoalloc(1) -farg3%data = c_loc(farg3_view) -farg3%size = size(numentriesperrowtoalloc) -else -farg3%data = c_null_ptr -farg3%size = 0 -end if -farg4 = pftype -fresult = swigc_new_TpetraCrsMatrix__SWIG_14(farg1, farg2, farg3, farg4) -self%swigdata = fresult -end function +farg1 = self%swigdata +farg2 = destmatrix%swigdata +farg3 = exporter%swigdata +farg4 = domainmap%swigdata +farg5 = rangemap%swigdata +call swigc_TpetraCrsMatrix_exportAndFillComplete__SWIG_1(farg1, farg2, farg3, farg4, farg5) +end subroutine -function new_TpetraCrsMatrix__SWIG_15(rowmap, colmap, numentriesperrowtoalloc) & -result(self) +subroutine swigf_TpetraCrsMatrix_exportAndFillComplete__SWIG_2(self, destmatrix, exporter, domainmap) use, intrinsic :: ISO_C_BINDING -type(TpetraCrsMatrix) :: self -class(TpetraMap), intent(in) :: rowmap +class(TpetraCrsMatrix), intent(in) :: self -class(TpetraMap), intent(in) :: colmap +class(TpetraCrsMatrix), intent(inout) :: destmatrix -integer(C_LONG), dimension(:), target :: numentriesperrowtoalloc -integer(C_LONG), pointer :: farg3_view +class(TpetraExport), intent(in) :: exporter + +class(TpetraMap), intent(in) :: domainmap -type(SwigClassWrapper) :: fresult type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 -type(SwigArrayWrapper) :: farg3 +type(SwigClassWrapper) :: farg3 +type(SwigClassWrapper) :: farg4 -farg1 = rowmap%swigdata -farg2 = colmap%swigdata -if (size(numentriesperrowtoalloc) > 0) then -farg3_view => numentriesperrowtoalloc(1) -farg3%data = c_loc(farg3_view) -farg3%size = size(numentriesperrowtoalloc) -else -farg3%data = c_null_ptr -farg3%size = 0 -end if -fresult = swigc_new_TpetraCrsMatrix__SWIG_15(farg1, farg2, farg3) -self%swigdata = fresult -end function +farg1 = self%swigdata +farg2 = destmatrix%swigdata +farg3 = exporter%swigdata +farg4 = domainmap%swigdata +call swigc_TpetraCrsMatrix_exportAndFillComplete__SWIG_2(farg1, farg2, farg3, farg4) +end subroutine -function new_TpetraCrsMatrix__SWIG_16(rowmap, colmap, rowpointers, columnindices, values, params) & -result(self) +subroutine swigf_TpetraCrsMatrix_exportAndFillComplete__SWIG_3(self, destmatrix, exporter) use, intrinsic :: ISO_C_BINDING -type(TpetraCrsMatrix) :: self -class(TpetraMap), intent(in) :: rowmap +class(TpetraCrsMatrix), intent(in) :: self -class(TpetraMap), intent(in) :: colmap +class(TpetraCrsMatrix), intent(inout) :: destmatrix -integer(C_LONG), dimension(:), target :: rowpointers -integer(C_LONG), pointer :: farg3_view -integer(C_INT), dimension(:), target :: columnindices -integer(C_INT), pointer :: farg4_view -real(C_DOUBLE), dimension(:), target :: values -real(C_DOUBLE), pointer :: farg5_view -class(ParameterList), intent(in) :: params +class(TpetraExport), intent(in) :: exporter -type(SwigClassWrapper) :: fresult type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 -type(SwigArrayWrapper) :: farg3 -type(SwigArrayWrapper) :: farg4 -type(SwigArrayWrapper) :: farg5 -type(SwigClassWrapper) :: farg6 +type(SwigClassWrapper) :: farg3 -farg1 = rowmap%swigdata -farg2 = colmap%swigdata -if (size(rowpointers) > 0) then -farg3_view => rowpointers(1) -farg3%data = c_loc(farg3_view) -farg3%size = size(rowpointers) -else -farg3%data = c_null_ptr -farg3%size = 0 -end if -if (size(columnindices) > 0) then -farg4_view => columnindices(1) -farg4%data = c_loc(farg4_view) -farg4%size = size(columnindices) -else -farg4%data = c_null_ptr -farg4%size = 0 -end if -if (size(values) > 0) then -farg5_view => values(1) -farg5%data = c_loc(farg5_view) -farg5%size = size(values) -else -farg5%data = c_null_ptr -farg5%size = 0 -end if -farg6 = params%swigdata -fresult = swigc_new_TpetraCrsMatrix__SWIG_16(farg1, farg2, farg3, farg4, farg5, farg6) -self%swigdata = fresult -end function +farg1 = self%swigdata +farg2 = destmatrix%swigdata +farg3 = exporter%swigdata +call swigc_TpetraCrsMatrix_exportAndFillComplete__SWIG_3(farg1, farg2, farg3) +end subroutine -function new_TpetraCrsMatrix__SWIG_17(rowmap, colmap, rowpointers, columnindices, values) & -result(self) +subroutine swigf_TpetraCrsMatrix_exportAndFillComplete__SWIG_4(self, destmatrix, rowexporter, domainexporter, domainmap, & + rangemap, params) use, intrinsic :: ISO_C_BINDING -type(TpetraCrsMatrix) :: self -class(TpetraMap), intent(in) :: rowmap +class(TpetraCrsMatrix), intent(in) :: self -class(TpetraMap), intent(in) :: colmap +class(TpetraCrsMatrix), intent(inout) :: destmatrix -integer(C_LONG), dimension(:), target :: rowpointers -integer(C_LONG), pointer :: farg3_view -integer(C_INT), dimension(:), target :: columnindices -integer(C_INT), pointer :: farg4_view -real(C_DOUBLE), dimension(:), target :: values -real(C_DOUBLE), pointer :: farg5_view +class(TpetraExport), intent(in) :: rowexporter + +class(TpetraExport), intent(in) :: domainexporter + +class(TpetraMap), intent(in) :: domainmap + +class(TpetraMap), intent(in) :: rangemap + +class(ParameterList), intent(in) :: params -type(SwigClassWrapper) :: fresult type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 -type(SwigArrayWrapper) :: farg3 -type(SwigArrayWrapper) :: farg4 -type(SwigArrayWrapper) :: farg5 +type(SwigClassWrapper) :: farg3 +type(SwigClassWrapper) :: farg4 +type(SwigClassWrapper) :: farg5 +type(SwigClassWrapper) :: farg6 +type(SwigClassWrapper) :: farg7 -farg1 = rowmap%swigdata -farg2 = colmap%swigdata -if (size(rowpointers) > 0) then -farg3_view => rowpointers(1) -farg3%data = c_loc(farg3_view) -farg3%size = size(rowpointers) -else -farg3%data = c_null_ptr -farg3%size = 0 -end if -if (size(columnindices) > 0) then -farg4_view => columnindices(1) -farg4%data = c_loc(farg4_view) -farg4%size = size(columnindices) -else -farg4%data = c_null_ptr -farg4%size = 0 -end if -if (size(values) > 0) then -farg5_view => values(1) -farg5%data = c_loc(farg5_view) -farg5%size = size(values) -else -farg5%data = c_null_ptr -farg5%size = 0 -end if -fresult = swigc_new_TpetraCrsMatrix__SWIG_17(farg1, farg2, farg3, farg4, farg5) -self%swigdata = fresult -end function +farg1 = self%swigdata +farg2 = destmatrix%swigdata +farg3 = rowexporter%swigdata +farg4 = domainexporter%swigdata +farg5 = domainmap%swigdata +farg6 = rangemap%swigdata +farg7 = params%swigdata +call swigc_TpetraCrsMatrix_exportAndFillComplete__SWIG_4(farg1, farg2, farg3, farg4, farg5, farg6, farg7) +end subroutine -subroutine swigf_TpetraCrsMatrix_setAllValues(self, ptr, ind, val) +subroutine swigf_TpetraCrsMatrix_computeGlobalConstants(self) use, intrinsic :: ISO_C_BINDING class(TpetraCrsMatrix), intent(inout) :: self -integer(C_LONG), dimension(:), target :: ptr -integer(C_LONG), pointer :: farg2_view -integer(C_INT), dimension(:), target :: ind -integer(C_INT), pointer :: farg3_view -real(C_DOUBLE), dimension(:), target :: val -real(C_DOUBLE), pointer :: farg4_view - type(SwigClassWrapper) :: farg1 -type(SwigArrayWrapper) :: farg2 -type(SwigArrayWrapper) :: farg3 -type(SwigArrayWrapper) :: farg4 farg1 = self%swigdata -if (size(ptr) > 0) then -farg2_view => ptr(1) -farg2%data = c_loc(farg2_view) -farg2%size = size(ptr) -else -farg2%data = c_null_ptr -farg2%size = 0 -end if -if (size(ind) > 0) then -farg3_view => ind(1) -farg3%data = c_loc(farg3_view) -farg3%size = size(ind) -else -farg3%data = c_null_ptr -farg3%size = 0 -end if -if (size(val) > 0) then -farg4_view => val(1) -farg4%data = c_loc(farg4_view) -farg4%size = size(val) -else -farg4%data = c_null_ptr -farg4%size = 0 -end if -call swigc_TpetraCrsMatrix_setAllValues(farg1, farg2, farg3, farg4) +call swigc_TpetraCrsMatrix_computeGlobalConstants(farg1) end subroutine +function swigf_TpetraCrsMatrix_haveGlobalConstants(self) & +result(swig_result) +use, intrinsic :: ISO_C_BINDING +logical :: swig_result +class(TpetraCrsMatrix), intent(in) :: self + +integer(C_INT) :: fresult +type(SwigClassWrapper) :: farg1 + +farg1 = self%swigdata +fresult = swigc_TpetraCrsMatrix_haveGlobalConstants(farg1) +swig_result = SWIG_int_to_logical(fresult) +end function + subroutine swigf_TpetraCrsMatrix_getAllValues(self, rowpointers, columnindices, values) use, intrinsic :: ISO_C_BINDING class(TpetraCrsMatrix), intent(in) :: self diff --git a/src/tpetra/src/swig/fortpetraFORTRAN_wrap.cxx b/src/tpetra/src/swig/fortpetraFORTRAN_wrap.cxx index 4de9f707..c26bac53 100644 --- a/src/tpetra/src/swig/fortpetraFORTRAN_wrap.cxx +++ b/src/tpetra/src/swig/fortpetraFORTRAN_wrap.cxx @@ -705,22 +705,6 @@ SwigClassWrapper swigd_ForTpetraOperator_getRangeMap( #include "Tpetra_CrsGraph.hpp" -SWIGINTERN Tpetra::CrsGraph< LO,GO,NO > *new_Tpetra_CrsGraph_Sl_LO_Sc_GO_Sc_NO_Sg___SWIG_6(Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &rowMap,Teuchos::ArrayView< std::size_t const > numEntPerRow,Tpetra::ProfileType const pftype=Tpetra::DynamicProfile,Teuchos::RCP< Teuchos::ParameterList > const ¶ms=Teuchos::null){ - return new Tpetra::CrsGraph(rowMap, arcpFromArrayView(numEntPerRow), pftype, params); - } -SWIGINTERN Tpetra::CrsGraph< LO,GO,NO > *new_Tpetra_CrsGraph_Sl_LO_Sc_GO_Sc_NO_Sg___SWIG_9(Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &rowMap,Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &colMap,Teuchos::ArrayView< std::size_t const > numEntPerRow,Tpetra::ProfileType const pftype=Tpetra::DynamicProfile,Teuchos::RCP< Teuchos::ParameterList > const ¶ms=Teuchos::null){ - return new Tpetra::CrsGraph(rowMap, colMap, arcpFromArrayView(numEntPerRow), pftype, params); - } -SWIGINTERN Tpetra::CrsGraph< LO,GO,NO > *new_Tpetra_CrsGraph_Sl_LO_Sc_GO_Sc_NO_Sg___SWIG_12(Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &rowMap,Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &colMap,Teuchos::ArrayView< std::size_t > rowPointers,Teuchos::ArrayView< LO > columnIndices,Teuchos::RCP< Teuchos::ParameterList > const ¶ms=Teuchos::null){ - Teuchos::Array rowPointersArray(rowPointers.size()); - for (size_t i = 0; i < rowPointers.size(); i++) - rowPointersArray[i] = rowPointers[i]-1; - Teuchos::Array columnIndicesArray(columnIndices.size()); - for (size_t i = 0; i < columnIndices.size(); i++) - columnIndicesArray[i] = columnIndices[i]-1; - return new Tpetra::CrsGraph(rowMap, colMap, - Teuchos::arcpFromArray(rowPointersArray), Teuchos::arcpFromArray(columnIndicesArray), params); - } SWIGINTERN void Tpetra_CrsGraph_Sl_LO_Sc_GO_Sc_NO_Sg__getNodeRowPtrs(Tpetra::CrsGraph< LO,GO,NO > const *self,Teuchos::ArrayView< std::size_t > rowPointers){ auto rowPointersArrayRCP = self->getNodeRowPtrs(); TEUCHOS_TEST_FOR_EXCEPTION(rowPointersArrayRCP.size() != rowPointers.size(), std::runtime_error, "Wrong rowPointers size"); @@ -750,31 +734,6 @@ SWIGINTERN void Tpetra_CrsGraph_Sl_LO_Sc_GO_Sc_NO_Sg__doExport__SWIG_1(Tpetra::C #include "Tpetra_CrsMatrix.hpp" -SWIGINTERN Tpetra::CrsMatrix< SC,LO,GO,NO > *new_Tpetra_CrsMatrix_Sl_SC_Sc_LO_Sc_GO_Sc_NO_Sg___SWIG_10(Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &rowMap,Teuchos::ArrayView< std::size_t const > NumEntriesPerRowToAlloc,Tpetra::ProfileType pftype=Tpetra::DynamicProfile,Teuchos::RCP< Teuchos::ParameterList > const ¶ms=Teuchos::null){ - return new Tpetra::CrsMatrix(rowMap, arcpFromArrayView(NumEntriesPerRowToAlloc), pftype, params); - } -SWIGINTERN Tpetra::CrsMatrix< SC,LO,GO,NO > *new_Tpetra_CrsMatrix_Sl_SC_Sc_LO_Sc_GO_Sc_NO_Sg___SWIG_13(Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &rowMap,Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &colMap,Teuchos::ArrayView< std::size_t const > NumEntriesPerRowToAlloc,Tpetra::ProfileType pftype=Tpetra::DynamicProfile,Teuchos::RCP< Teuchos::ParameterList > const ¶ms=Teuchos::null){ - return new Tpetra::CrsMatrix(rowMap, colMap, arcpFromArrayView(NumEntriesPerRowToAlloc), pftype, params); - } -SWIGINTERN Tpetra::CrsMatrix< SC,LO,GO,NO > *new_Tpetra_CrsMatrix_Sl_SC_Sc_LO_Sc_GO_Sc_NO_Sg___SWIG_16(Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &rowMap,Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &colMap,Teuchos::ArrayView< std::size_t > rowPointers,Teuchos::ArrayView< LO > columnIndices,Teuchos::ArrayView< SC > values,Teuchos::RCP< Teuchos::ParameterList > const ¶ms=Teuchos::null){ - Teuchos::ArrayRCP rowPointersArrayRCP(rowPointers.size()); - for (int i = 0; i < rowPointersArrayRCP.size(); i++) - rowPointersArrayRCP[i] = rowPointers[i]-1; - Teuchos::ArrayRCP columnIndicesArrayRCP(columnIndices.size()); - for (int i = 0; i < columnIndicesArrayRCP.size(); i++) - columnIndicesArrayRCP[i] = columnIndices[i]-1; - return new Tpetra::CrsMatrix(rowMap, colMap, rowPointersArrayRCP, columnIndicesArrayRCP, arcpFromArrayView(values), params); - } -SWIGINTERN void Tpetra_CrsMatrix_Sl_SC_Sc_LO_Sc_GO_Sc_NO_Sg__setAllValues(Tpetra::CrsMatrix< SC,LO,GO,NO > *self,Teuchos::ArrayView< std::size_t > ptr,Teuchos::ArrayView< LO > ind,Teuchos::ArrayView< SC > val){ - Teuchos::ArrayRCP ptrArrayRCP(ptr.size()); - for (int i = 0; i < ptrArrayRCP.size(); i++) - ptrArrayRCP[i] = ptr[i]-1; - Teuchos::ArrayRCP indArrayRCP(ind.size()); - for (int i = 0; i < indArrayRCP.size(); i++) - indArrayRCP[i] = ind[i]-1; - Teuchos::ArrayRCP valArrayRCP(val.getRawPtr(), 0, val.size(), false/*has_ownership*/); - self->setAllValues(arcpFromArrayView(ptr), arcpFromArrayView(ind), arcpFromArrayView(val)); - } SWIGINTERN void Tpetra_CrsMatrix_Sl_SC_Sc_LO_Sc_GO_Sc_NO_Sg__getAllValues(Tpetra::CrsMatrix< SC,LO,GO,NO > const *self,Teuchos::ArrayView< std::size_t > rowPointers,Teuchos::ArrayView< LO > columnIndices,Teuchos::ArrayView< SC > values){ Teuchos::ArrayRCP rowPointersArrayRCP; Teuchos::ArrayRCP columnIndicesArrayRCP; @@ -6789,7 +6748,134 @@ SWIGEXPORT SwigClassWrapper _wrap_new_TpetraCrsGraph__SWIG_2(SwigClassWrapper co } -SWIGEXPORT SwigClassWrapper _wrap_new_TpetraCrsGraph__SWIG_3(SwigClassWrapper const *farg1, SwigClassWrapper const *farg2, size_t const *farg3, int const *farg4, SwigClassWrapper const *farg5) { +SWIGEXPORT SwigClassWrapper _wrap_new_TpetraCrsGraph__SWIG_3(SwigClassWrapper const *farg1, SwigArrayWrapper *farg2, int const *farg3, SwigClassWrapper const *farg4) { + SwigClassWrapper fresult ; + Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > *arg1 = 0 ; + Teuchos::ArrayRCP< std::size_t const > *arg2 = 0 ; + Tpetra::ProfileType arg3 ; + Teuchos::RCP< Teuchos::ParameterList > *arg4 = 0 ; + Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > tempnull1 ; + Teuchos::ArrayRCP< unsigned long const > tmparr2 ; + Teuchos::RCP< Teuchos::ParameterList > tempnull4 ; + Tpetra::CrsGraph< LO,GO,NO > *result = 0 ; + + arg1 = farg1->cptr ? static_cast< Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg1->cptr) : &tempnull1; + tmparr2 = Teuchos::ArrayRCP(static_cast(farg2->data), 0, farg2->size, false, Teuchos::RCP_DISABLE_NODE_LOOKUP); + arg2 = &tmparr2; + arg3 = static_cast< Tpetra::ProfileType >(*farg3); + arg4 = farg4->cptr ? static_cast< Teuchos::RCP< Teuchos::ParameterList > * >(farg4->cptr) : &tempnull4; + { + // Make sure no unhandled exceptions exist before performing a new action + SWIG_check_unhandled_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::CrsGraph(Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::ArrayRCP< std::size_t const > const &,Tpetra::ProfileType const,Teuchos::RCP< Teuchos::ParameterList > const &)");; + try + { + // Attempt the wrapped function call + result = (Tpetra::CrsGraph< LO,GO,NO > *)new Tpetra::CrsGraph< LO,GO,NO >((Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &)*arg1,(Teuchos::ArrayRCP< std::size_t const > const &)*arg2,arg3,(Teuchos::RCP< Teuchos::ParameterList > const &)*arg4); + } + catch (const std::range_error& e) + { + // Store a C++ exception + SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::CrsGraph(Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::ArrayRCP< std::size_t const > const &,Tpetra::ProfileType const,Teuchos::RCP< Teuchos::ParameterList > const &)", SWIG_IndexError, e.what(), return SwigClassWrapper_uninitialized()); + } + catch (const std::exception& e) + { + // Store a C++ exception + SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::CrsGraph(Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::ArrayRCP< std::size_t const > const &,Tpetra::ProfileType const,Teuchos::RCP< Teuchos::ParameterList > const &)", SWIG_RuntimeError, e.what(), return SwigClassWrapper_uninitialized()); + } + catch (...) + { + SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::CrsGraph(Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::ArrayRCP< std::size_t const > const &,Tpetra::ProfileType const,Teuchos::RCP< Teuchos::ParameterList > const &)", SWIG_UnknownError, "An unknown exception occurred", return SwigClassWrapper_uninitialized()); + } + } + fresult.cptr = result ? new Teuchos::RCP< Tpetra::CrsGraph >(result SWIG_NO_NULL_DELETER_1) : NULL; + fresult.mem = SWIG_MOVE; + return fresult; +} + + +SWIGEXPORT SwigClassWrapper _wrap_new_TpetraCrsGraph__SWIG_4(SwigClassWrapper const *farg1, SwigArrayWrapper *farg2, int const *farg3) { + SwigClassWrapper fresult ; + Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > *arg1 = 0 ; + Teuchos::ArrayRCP< std::size_t const > *arg2 = 0 ; + Tpetra::ProfileType arg3 ; + Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > tempnull1 ; + Teuchos::ArrayRCP< unsigned long const > tmparr2 ; + Tpetra::CrsGraph< LO,GO,NO > *result = 0 ; + + arg1 = farg1->cptr ? static_cast< Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg1->cptr) : &tempnull1; + tmparr2 = Teuchos::ArrayRCP(static_cast(farg2->data), 0, farg2->size, false, Teuchos::RCP_DISABLE_NODE_LOOKUP); + arg2 = &tmparr2; + arg3 = static_cast< Tpetra::ProfileType >(*farg3); + { + // Make sure no unhandled exceptions exist before performing a new action + SWIG_check_unhandled_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::CrsGraph(Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::ArrayRCP< std::size_t const > const &,Tpetra::ProfileType const)");; + try + { + // Attempt the wrapped function call + result = (Tpetra::CrsGraph< LO,GO,NO > *)new Tpetra::CrsGraph< LO,GO,NO >((Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &)*arg1,(Teuchos::ArrayRCP< std::size_t const > const &)*arg2,arg3); + } + catch (const std::range_error& e) + { + // Store a C++ exception + SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::CrsGraph(Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::ArrayRCP< std::size_t const > const &,Tpetra::ProfileType const)", SWIG_IndexError, e.what(), return SwigClassWrapper_uninitialized()); + } + catch (const std::exception& e) + { + // Store a C++ exception + SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::CrsGraph(Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::ArrayRCP< std::size_t const > const &,Tpetra::ProfileType const)", SWIG_RuntimeError, e.what(), return SwigClassWrapper_uninitialized()); + } + catch (...) + { + SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::CrsGraph(Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::ArrayRCP< std::size_t const > const &,Tpetra::ProfileType const)", SWIG_UnknownError, "An unknown exception occurred", return SwigClassWrapper_uninitialized()); + } + } + fresult.cptr = result ? new Teuchos::RCP< Tpetra::CrsGraph >(result SWIG_NO_NULL_DELETER_1) : NULL; + fresult.mem = SWIG_MOVE; + return fresult; +} + + +SWIGEXPORT SwigClassWrapper _wrap_new_TpetraCrsGraph__SWIG_5(SwigClassWrapper const *farg1, SwigArrayWrapper *farg2) { + SwigClassWrapper fresult ; + Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > *arg1 = 0 ; + Teuchos::ArrayRCP< std::size_t const > *arg2 = 0 ; + Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > tempnull1 ; + Teuchos::ArrayRCP< unsigned long const > tmparr2 ; + Tpetra::CrsGraph< LO,GO,NO > *result = 0 ; + + arg1 = farg1->cptr ? static_cast< Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg1->cptr) : &tempnull1; + tmparr2 = Teuchos::ArrayRCP(static_cast(farg2->data), 0, farg2->size, false, Teuchos::RCP_DISABLE_NODE_LOOKUP); + arg2 = &tmparr2; + { + // Make sure no unhandled exceptions exist before performing a new action + SWIG_check_unhandled_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::CrsGraph(Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::ArrayRCP< std::size_t const > const &)");; + try + { + // Attempt the wrapped function call + result = (Tpetra::CrsGraph< LO,GO,NO > *)new Tpetra::CrsGraph< LO,GO,NO >((Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &)*arg1,(Teuchos::ArrayRCP< std::size_t const > const &)*arg2); + } + catch (const std::range_error& e) + { + // Store a C++ exception + SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::CrsGraph(Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::ArrayRCP< std::size_t const > const &)", SWIG_IndexError, e.what(), return SwigClassWrapper_uninitialized()); + } + catch (const std::exception& e) + { + // Store a C++ exception + SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::CrsGraph(Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::ArrayRCP< std::size_t const > const &)", SWIG_RuntimeError, e.what(), return SwigClassWrapper_uninitialized()); + } + catch (...) + { + SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::CrsGraph(Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::ArrayRCP< std::size_t const > const &)", SWIG_UnknownError, "An unknown exception occurred", return SwigClassWrapper_uninitialized()); + } + } + fresult.cptr = result ? new Teuchos::RCP< Tpetra::CrsGraph >(result SWIG_NO_NULL_DELETER_1) : NULL; + fresult.mem = SWIG_MOVE; + return fresult; +} + + +SWIGEXPORT SwigClassWrapper _wrap_new_TpetraCrsGraph__SWIG_6(SwigClassWrapper const *farg1, SwigClassWrapper const *farg2, size_t const *farg3, int const *farg4, SwigClassWrapper const *farg5) { SwigClassWrapper fresult ; Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > *arg1 = 0 ; Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > *arg2 = 0 ; @@ -6835,7 +6921,7 @@ SWIGEXPORT SwigClassWrapper _wrap_new_TpetraCrsGraph__SWIG_3(SwigClassWrapper co } -SWIGEXPORT SwigClassWrapper _wrap_new_TpetraCrsGraph__SWIG_4(SwigClassWrapper const *farg1, SwigClassWrapper const *farg2, size_t const *farg3, int const *farg4) { +SWIGEXPORT SwigClassWrapper _wrap_new_TpetraCrsGraph__SWIG_7(SwigClassWrapper const *farg1, SwigClassWrapper const *farg2, size_t const *farg3, int const *farg4) { SwigClassWrapper fresult ; Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > *arg1 = 0 ; Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > *arg2 = 0 ; @@ -6878,7 +6964,7 @@ SWIGEXPORT SwigClassWrapper _wrap_new_TpetraCrsGraph__SWIG_4(SwigClassWrapper co } -SWIGEXPORT SwigClassWrapper _wrap_new_TpetraCrsGraph__SWIG_5(SwigClassWrapper const *farg1, SwigClassWrapper const *farg2, size_t const *farg3) { +SWIGEXPORT SwigClassWrapper _wrap_new_TpetraCrsGraph__SWIG_8(SwigClassWrapper const *farg1, SwigClassWrapper const *farg2, size_t const *farg3) { SwigClassWrapper fresult ; Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > *arg1 = 0 ; Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > *arg2 = 0 ; @@ -6919,215 +7005,472 @@ SWIGEXPORT SwigClassWrapper _wrap_new_TpetraCrsGraph__SWIG_5(SwigClassWrapper co } -SWIGEXPORT void _wrap_delete_TpetraCrsGraph(SwigClassWrapper const *farg1) { - Tpetra::CrsGraph< LO,GO,NO > *arg1 = (Tpetra::CrsGraph< LO,GO,NO > *) 0 ; - Teuchos::RCP< Tpetra::CrsGraph< LO,GO,NO > > *smartarg1 ; +SWIGEXPORT SwigClassWrapper _wrap_new_TpetraCrsGraph__SWIG_9(SwigClassWrapper const *farg1, SwigClassWrapper const *farg2, SwigArrayWrapper *farg3, int const *farg4, SwigClassWrapper const *farg5) { + SwigClassWrapper fresult ; + Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > *arg1 = 0 ; + Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > *arg2 = 0 ; + Teuchos::ArrayRCP< std::size_t const > *arg3 = 0 ; + Tpetra::ProfileType arg4 ; + Teuchos::RCP< Teuchos::ParameterList > *arg5 = 0 ; + Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > tempnull1 ; + Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > tempnull2 ; + Teuchos::ArrayRCP< unsigned long const > tmparr3 ; + Teuchos::RCP< Teuchos::ParameterList > tempnull5 ; + Tpetra::CrsGraph< LO,GO,NO > *result = 0 ; - smartarg1 = static_cast< Teuchos::RCP< Tpetra::CrsGraph >* >(farg1->cptr); - arg1 = smartarg1 ? const_cast< Tpetra::CrsGraph* >(smartarg1->get()) : NULL; + arg1 = farg1->cptr ? static_cast< Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg1->cptr) : &tempnull1; + arg2 = farg2->cptr ? static_cast< Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg2->cptr) : &tempnull2; + tmparr3 = Teuchos::ArrayRCP(static_cast(farg3->data), 0, farg3->size, false, Teuchos::RCP_DISABLE_NODE_LOOKUP); + arg3 = &tmparr3; + arg4 = static_cast< Tpetra::ProfileType >(*farg4); + arg5 = farg5->cptr ? static_cast< Teuchos::RCP< Teuchos::ParameterList > * >(farg5->cptr) : &tempnull5; { // Make sure no unhandled exceptions exist before performing a new action - SWIG_check_unhandled_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::~CrsGraph()");; + SWIG_check_unhandled_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::CrsGraph(Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::ArrayRCP< std::size_t const > const &,Tpetra::ProfileType const,Teuchos::RCP< Teuchos::ParameterList > const &)");; try { // Attempt the wrapped function call - (void)arg1; delete smartarg1; + result = (Tpetra::CrsGraph< LO,GO,NO > *)new Tpetra::CrsGraph< LO,GO,NO >((Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &)*arg1,(Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &)*arg2,(Teuchos::ArrayRCP< std::size_t const > const &)*arg3,arg4,(Teuchos::RCP< Teuchos::ParameterList > const &)*arg5); } catch (const std::range_error& e) { // Store a C++ exception - SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::~CrsGraph()", SWIG_IndexError, e.what(), return ); + SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::CrsGraph(Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::ArrayRCP< std::size_t const > const &,Tpetra::ProfileType const,Teuchos::RCP< Teuchos::ParameterList > const &)", SWIG_IndexError, e.what(), return SwigClassWrapper_uninitialized()); } catch (const std::exception& e) { // Store a C++ exception - SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::~CrsGraph()", SWIG_RuntimeError, e.what(), return ); + SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::CrsGraph(Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::ArrayRCP< std::size_t const > const &,Tpetra::ProfileType const,Teuchos::RCP< Teuchos::ParameterList > const &)", SWIG_RuntimeError, e.what(), return SwigClassWrapper_uninitialized()); } catch (...) { - SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::~CrsGraph()", SWIG_UnknownError, "An unknown exception occurred", return ); + SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::CrsGraph(Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::ArrayRCP< std::size_t const > const &,Tpetra::ProfileType const,Teuchos::RCP< Teuchos::ParameterList > const &)", SWIG_UnknownError, "An unknown exception occurred", return SwigClassWrapper_uninitialized()); } } - + fresult.cptr = result ? new Teuchos::RCP< Tpetra::CrsGraph >(result SWIG_NO_NULL_DELETER_1) : NULL; + fresult.mem = SWIG_MOVE; + return fresult; } -SWIGEXPORT void _wrap_TpetraCrsGraph_swap(SwigClassWrapper const *farg1, SwigClassWrapper const *farg2) { - Tpetra::CrsGraph< LO,GO,NO > *arg1 = (Tpetra::CrsGraph< LO,GO,NO > *) 0 ; - Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode > *arg2 = 0 ; - Teuchos::RCP< Tpetra::CrsGraph< LO,GO,NO > > *smartarg1 ; - Teuchos::RCP< Tpetra::CrsGraph< LO,GO,NO > > *smartarg2 ; +SWIGEXPORT SwigClassWrapper _wrap_new_TpetraCrsGraph__SWIG_10(SwigClassWrapper const *farg1, SwigClassWrapper const *farg2, SwigArrayWrapper *farg3, int const *farg4) { + SwigClassWrapper fresult ; + Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > *arg1 = 0 ; + Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > *arg2 = 0 ; + Teuchos::ArrayRCP< std::size_t const > *arg3 = 0 ; + Tpetra::ProfileType arg4 ; + Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > tempnull1 ; + Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > tempnull2 ; + Teuchos::ArrayRCP< unsigned long const > tmparr3 ; + Tpetra::CrsGraph< LO,GO,NO > *result = 0 ; - smartarg1 = static_cast< Teuchos::RCP< Tpetra::CrsGraph >* >(farg1->cptr); - arg1 = smartarg1 ? const_cast< Tpetra::CrsGraph* >(smartarg1->get()) : NULL; - SWIG_check_sp_nonnull(farg2, "Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode > *", "TpetraCrsGraph", "Tpetra::CrsGraph< LO,GO,NO >::swap(Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode > &)", return ) - smartarg2 = static_cast< Teuchos::RCP< Tpetra::CrsGraph >* >(farg2->cptr); - arg2 = const_cast< Tpetra::CrsGraph* >(smartarg2->get()); + arg1 = farg1->cptr ? static_cast< Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg1->cptr) : &tempnull1; + arg2 = farg2->cptr ? static_cast< Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg2->cptr) : &tempnull2; + tmparr3 = Teuchos::ArrayRCP(static_cast(farg3->data), 0, farg3->size, false, Teuchos::RCP_DISABLE_NODE_LOOKUP); + arg3 = &tmparr3; + arg4 = static_cast< Tpetra::ProfileType >(*farg4); { // Make sure no unhandled exceptions exist before performing a new action - SWIG_check_unhandled_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::swap(Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode > &)");; + SWIG_check_unhandled_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::CrsGraph(Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::ArrayRCP< std::size_t const > const &,Tpetra::ProfileType const)");; try { // Attempt the wrapped function call - (arg1)->swap(*arg2); + result = (Tpetra::CrsGraph< LO,GO,NO > *)new Tpetra::CrsGraph< LO,GO,NO >((Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &)*arg1,(Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &)*arg2,(Teuchos::ArrayRCP< std::size_t const > const &)*arg3,arg4); } catch (const std::range_error& e) { // Store a C++ exception - SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::swap(Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode > &)", SWIG_IndexError, e.what(), return ); + SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::CrsGraph(Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::ArrayRCP< std::size_t const > const &,Tpetra::ProfileType const)", SWIG_IndexError, e.what(), return SwigClassWrapper_uninitialized()); } catch (const std::exception& e) { // Store a C++ exception - SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::swap(Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode > &)", SWIG_RuntimeError, e.what(), return ); + SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::CrsGraph(Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::ArrayRCP< std::size_t const > const &,Tpetra::ProfileType const)", SWIG_RuntimeError, e.what(), return SwigClassWrapper_uninitialized()); } catch (...) { - SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::swap(Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode > &)", SWIG_UnknownError, "An unknown exception occurred", return ); + SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::CrsGraph(Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::ArrayRCP< std::size_t const > const &,Tpetra::ProfileType const)", SWIG_UnknownError, "An unknown exception occurred", return SwigClassWrapper_uninitialized()); } } - + fresult.cptr = result ? new Teuchos::RCP< Tpetra::CrsGraph >(result SWIG_NO_NULL_DELETER_1) : NULL; + fresult.mem = SWIG_MOVE; + return fresult; } -SWIGEXPORT int _wrap_TpetraCrsGraph_isIdenticalTo(SwigClassWrapper const *farg1, SwigClassWrapper const *farg2) { - int fresult ; - Tpetra::CrsGraph< LO,GO,NO > *arg1 = (Tpetra::CrsGraph< LO,GO,NO > *) 0 ; - Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode > *arg2 = 0 ; - Teuchos::RCP< Tpetra::CrsGraph< LO,GO,NO > const > *smartarg1 ; - Teuchos::RCP< Tpetra::CrsGraph< LO,GO,NO > const > *smartarg2 ; - bool result; +SWIGEXPORT SwigClassWrapper _wrap_new_TpetraCrsGraph__SWIG_11(SwigClassWrapper const *farg1, SwigClassWrapper const *farg2, SwigArrayWrapper *farg3) { + SwigClassWrapper fresult ; + Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > *arg1 = 0 ; + Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > *arg2 = 0 ; + Teuchos::ArrayRCP< std::size_t const > *arg3 = 0 ; + Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > tempnull1 ; + Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > tempnull2 ; + Teuchos::ArrayRCP< unsigned long const > tmparr3 ; + Tpetra::CrsGraph< LO,GO,NO > *result = 0 ; - smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); - arg1 = smartarg1 ? const_cast< Tpetra::CrsGraph* >(smartarg1->get()) : NULL; - SWIG_check_sp_nonnull(farg2, "Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode > *", "TpetraCrsGraph", "Tpetra::CrsGraph< LO,GO,NO >::isIdenticalTo(Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &) const", return 0) - smartarg2 = static_cast< Teuchos::RCP >* >(farg2->cptr); - arg2 = const_cast< Tpetra::CrsGraph* >(smartarg2->get()); + arg1 = farg1->cptr ? static_cast< Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg1->cptr) : &tempnull1; + arg2 = farg2->cptr ? static_cast< Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg2->cptr) : &tempnull2; + tmparr3 = Teuchos::ArrayRCP(static_cast(farg3->data), 0, farg3->size, false, Teuchos::RCP_DISABLE_NODE_LOOKUP); + arg3 = &tmparr3; { // Make sure no unhandled exceptions exist before performing a new action - SWIG_check_unhandled_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::isIdenticalTo(Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &) const");; + SWIG_check_unhandled_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::CrsGraph(Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::ArrayRCP< std::size_t const > const &)");; try { // Attempt the wrapped function call - result = (bool)((Tpetra::CrsGraph< LO,GO,NO > const *)arg1)->isIdenticalTo((Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &)*arg2); + result = (Tpetra::CrsGraph< LO,GO,NO > *)new Tpetra::CrsGraph< LO,GO,NO >((Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &)*arg1,(Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &)*arg2,(Teuchos::ArrayRCP< std::size_t const > const &)*arg3); } catch (const std::range_error& e) { // Store a C++ exception - SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::isIdenticalTo(Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &) const", SWIG_IndexError, e.what(), return 0); + SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::CrsGraph(Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::ArrayRCP< std::size_t const > const &)", SWIG_IndexError, e.what(), return SwigClassWrapper_uninitialized()); } catch (const std::exception& e) { // Store a C++ exception - SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::isIdenticalTo(Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &) const", SWIG_RuntimeError, e.what(), return 0); + SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::CrsGraph(Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::ArrayRCP< std::size_t const > const &)", SWIG_RuntimeError, e.what(), return SwigClassWrapper_uninitialized()); } catch (...) { - SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::isIdenticalTo(Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &) const", SWIG_UnknownError, "An unknown exception occurred", return 0); + SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::CrsGraph(Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::ArrayRCP< std::size_t const > const &)", SWIG_UnknownError, "An unknown exception occurred", return SwigClassWrapper_uninitialized()); } } - fresult = (result ? 1 : 0); + fresult.cptr = result ? new Teuchos::RCP< Tpetra::CrsGraph >(result SWIG_NO_NULL_DELETER_1) : NULL; + fresult.mem = SWIG_MOVE; return fresult; } -SWIGEXPORT void _wrap_TpetraCrsGraph_setParameterList(SwigClassWrapper const *farg1, SwigClassWrapper const *farg2) { - Tpetra::CrsGraph< LO,GO,NO > *arg1 = (Tpetra::CrsGraph< LO,GO,NO > *) 0 ; - Teuchos::RCP< Teuchos::ParameterList > *arg2 = 0 ; - Teuchos::RCP< Tpetra::CrsGraph< LO,GO,NO > > *smartarg1 ; - Teuchos::RCP< Teuchos::ParameterList > tempnull2 ; +SWIGEXPORT SwigClassWrapper _wrap_new_TpetraCrsGraph__SWIG_12(SwigClassWrapper const *farg1, SwigClassWrapper const *farg2, SwigArrayWrapper *farg3, SwigArrayWrapper *farg4, SwigClassWrapper const *farg5) { + SwigClassWrapper fresult ; + Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > *arg1 = 0 ; + Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > *arg2 = 0 ; + Teuchos::ArrayRCP< std::size_t > *arg3 = 0 ; + Teuchos::ArrayRCP< int > *arg4 = 0 ; + Teuchos::RCP< Teuchos::ParameterList > *arg5 = 0 ; + Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > tempnull1 ; + Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > tempnull2 ; + Teuchos::ArrayRCP< std::size_t >::value_type *tmpbegin3 ; + Teuchos::ArrayRCP< std::remove_const< Teuchos::ArrayRCP< std::size_t >::value_type >::type > tmparr3 ; + Teuchos::ArrayRCP< std::size_t > tmprcp3 ; + Teuchos::ArrayRCP< int >::value_type *tmpbegin4 ; + Teuchos::ArrayRCP< std::remove_const< Teuchos::ArrayRCP< int >::value_type >::type > tmparr4 ; + Teuchos::ArrayRCP< int > tmprcp4 ; + Teuchos::RCP< Teuchos::ParameterList > tempnull5 ; + Tpetra::CrsGraph< LO,GO,NO > *result = 0 ; - smartarg1 = static_cast< Teuchos::RCP< Tpetra::CrsGraph >* >(farg1->cptr); - arg1 = smartarg1 ? const_cast< Tpetra::CrsGraph* >(smartarg1->get()) : NULL; - arg2 = farg2->cptr ? static_cast< Teuchos::RCP< Teuchos::ParameterList > * >(farg2->cptr) : &tempnull2; + arg1 = farg1->cptr ? static_cast< Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg1->cptr) : &tempnull1; + arg2 = farg2->cptr ? static_cast< Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg2->cptr) : &tempnull2; + tmpbegin3 = static_cast::value_type*>(farg3->data); + tmparr3.resize(farg3->size); + for (int i = 0; i < tmparr3.size(); i++) + tmparr3[i] = tmpbegin3[i] - 1; + tmprcp3 = tmparr3; + arg3 = &tmprcp3; + tmpbegin4 = static_cast::value_type*>(farg4->data); + tmparr4.resize(farg4->size); + for (int i = 0; i < tmparr4.size(); i++) + tmparr4[i] = tmpbegin4[i] - 1; + tmprcp4 = tmparr4; + arg4 = &tmprcp4; + arg5 = farg5->cptr ? static_cast< Teuchos::RCP< Teuchos::ParameterList > * >(farg5->cptr) : &tempnull5; { // Make sure no unhandled exceptions exist before performing a new action - SWIG_check_unhandled_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::setParameterList(Teuchos::RCP< Teuchos::ParameterList > const &)");; + SWIG_check_unhandled_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::CrsGraph(Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::ArrayRCP< std::size_t > const &,Teuchos::ArrayRCP< int > const &,Teuchos::RCP< Teuchos::ParameterList > const &)");; try { // Attempt the wrapped function call - (arg1)->setParameterList((Teuchos::RCP< Teuchos::ParameterList > const &)*arg2); + result = (Tpetra::CrsGraph< LO,GO,NO > *)new Tpetra::CrsGraph< LO,GO,NO >((Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &)*arg1,(Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &)*arg2,(Teuchos::ArrayRCP< std::size_t > const &)*arg3,(Teuchos::ArrayRCP< int > const &)*arg4,(Teuchos::RCP< Teuchos::ParameterList > const &)*arg5); } catch (const std::range_error& e) { // Store a C++ exception - SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::setParameterList(Teuchos::RCP< Teuchos::ParameterList > const &)", SWIG_IndexError, e.what(), return ); + SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::CrsGraph(Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::ArrayRCP< std::size_t > const &,Teuchos::ArrayRCP< int > const &,Teuchos::RCP< Teuchos::ParameterList > const &)", SWIG_IndexError, e.what(), return SwigClassWrapper_uninitialized()); } catch (const std::exception& e) { // Store a C++ exception - SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::setParameterList(Teuchos::RCP< Teuchos::ParameterList > const &)", SWIG_RuntimeError, e.what(), return ); + SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::CrsGraph(Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::ArrayRCP< std::size_t > const &,Teuchos::ArrayRCP< int > const &,Teuchos::RCP< Teuchos::ParameterList > const &)", SWIG_RuntimeError, e.what(), return SwigClassWrapper_uninitialized()); } catch (...) { - SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::setParameterList(Teuchos::RCP< Teuchos::ParameterList > const &)", SWIG_UnknownError, "An unknown exception occurred", return ); + SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::CrsGraph(Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::ArrayRCP< std::size_t > const &,Teuchos::ArrayRCP< int > const &,Teuchos::RCP< Teuchos::ParameterList > const &)", SWIG_UnknownError, "An unknown exception occurred", return SwigClassWrapper_uninitialized()); } } - + fresult.cptr = result ? new Teuchos::RCP< Tpetra::CrsGraph >(result SWIG_NO_NULL_DELETER_1) : NULL; + fresult.mem = SWIG_MOVE; + return fresult; } -SWIGEXPORT SwigClassWrapper _wrap_TpetraCrsGraph_getValidParameters(SwigClassWrapper const *farg1) { +SWIGEXPORT SwigClassWrapper _wrap_new_TpetraCrsGraph__SWIG_13(SwigClassWrapper const *farg1, SwigClassWrapper const *farg2, SwigArrayWrapper *farg3, SwigArrayWrapper *farg4) { SwigClassWrapper fresult ; - Tpetra::CrsGraph< LO,GO,NO > *arg1 = (Tpetra::CrsGraph< LO,GO,NO > *) 0 ; - Teuchos::RCP< Tpetra::CrsGraph< LO,GO,NO > const > *smartarg1 ; - Teuchos::RCP< Teuchos::ParameterList const > result; + Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > *arg1 = 0 ; + Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > *arg2 = 0 ; + Teuchos::ArrayRCP< std::size_t > *arg3 = 0 ; + Teuchos::ArrayRCP< int > *arg4 = 0 ; + Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > tempnull1 ; + Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > tempnull2 ; + Teuchos::ArrayRCP< std::size_t >::value_type *tmpbegin3 ; + Teuchos::ArrayRCP< std::remove_const< Teuchos::ArrayRCP< std::size_t >::value_type >::type > tmparr3 ; + Teuchos::ArrayRCP< std::size_t > tmprcp3 ; + Teuchos::ArrayRCP< int >::value_type *tmpbegin4 ; + Teuchos::ArrayRCP< std::remove_const< Teuchos::ArrayRCP< int >::value_type >::type > tmparr4 ; + Teuchos::ArrayRCP< int > tmprcp4 ; + Tpetra::CrsGraph< LO,GO,NO > *result = 0 ; - smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); - arg1 = smartarg1 ? const_cast< Tpetra::CrsGraph* >(smartarg1->get()) : NULL; + arg1 = farg1->cptr ? static_cast< Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg1->cptr) : &tempnull1; + arg2 = farg2->cptr ? static_cast< Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg2->cptr) : &tempnull2; + tmpbegin3 = static_cast::value_type*>(farg3->data); + tmparr3.resize(farg3->size); + for (int i = 0; i < tmparr3.size(); i++) + tmparr3[i] = tmpbegin3[i] - 1; + tmprcp3 = tmparr3; + arg3 = &tmprcp3; + tmpbegin4 = static_cast::value_type*>(farg4->data); + tmparr4.resize(farg4->size); + for (int i = 0; i < tmparr4.size(); i++) + tmparr4[i] = tmpbegin4[i] - 1; + tmprcp4 = tmparr4; + arg4 = &tmprcp4; { // Make sure no unhandled exceptions exist before performing a new action - SWIG_check_unhandled_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::getValidParameters() const");; + SWIG_check_unhandled_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::CrsGraph(Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::ArrayRCP< std::size_t > const &,Teuchos::ArrayRCP< int > const &)");; try { // Attempt the wrapped function call - result = ((Tpetra::CrsGraph< LO,GO,NO > const *)arg1)->getValidParameters(); + result = (Tpetra::CrsGraph< LO,GO,NO > *)new Tpetra::CrsGraph< LO,GO,NO >((Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &)*arg1,(Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &)*arg2,(Teuchos::ArrayRCP< std::size_t > const &)*arg3,(Teuchos::ArrayRCP< int > const &)*arg4); } catch (const std::range_error& e) { // Store a C++ exception - SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::getValidParameters() const", SWIG_IndexError, e.what(), return SwigClassWrapper_uninitialized()); + SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::CrsGraph(Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::ArrayRCP< std::size_t > const &,Teuchos::ArrayRCP< int > const &)", SWIG_IndexError, e.what(), return SwigClassWrapper_uninitialized()); } catch (const std::exception& e) { // Store a C++ exception - SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::getValidParameters() const", SWIG_RuntimeError, e.what(), return SwigClassWrapper_uninitialized()); + SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::CrsGraph(Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::ArrayRCP< std::size_t > const &,Teuchos::ArrayRCP< int > const &)", SWIG_RuntimeError, e.what(), return SwigClassWrapper_uninitialized()); } catch (...) { - SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::getValidParameters() const", SWIG_UnknownError, "An unknown exception occurred", return SwigClassWrapper_uninitialized()); + SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::CrsGraph(Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::ArrayRCP< std::size_t > const &,Teuchos::ArrayRCP< int > const &)", SWIG_UnknownError, "An unknown exception occurred", return SwigClassWrapper_uninitialized()); } } - fresult.cptr = (new Teuchos::RCP(static_cast< const Teuchos::RCP& >(result))); + fresult.cptr = result ? new Teuchos::RCP< Tpetra::CrsGraph >(result SWIG_NO_NULL_DELETER_1) : NULL; fresult.mem = SWIG_MOVE; return fresult; } -SWIGEXPORT void _wrap_TpetraCrsGraph_insertGlobalIndices__SWIG_0(SwigClassWrapper const *farg1, long long const *farg2, SwigArrayWrapper *farg3) { +SWIGEXPORT void _wrap_delete_TpetraCrsGraph(SwigClassWrapper const *farg1) { Tpetra::CrsGraph< LO,GO,NO > *arg1 = (Tpetra::CrsGraph< LO,GO,NO > *) 0 ; - long long arg2 ; - Teuchos::ArrayView< long long const > *arg3 = 0 ; Teuchos::RCP< Tpetra::CrsGraph< LO,GO,NO > > *smartarg1 ; - Teuchos::ArrayView< long long const > tmpview3 ; smartarg1 = static_cast< Teuchos::RCP< Tpetra::CrsGraph >* >(farg1->cptr); arg1 = smartarg1 ? const_cast< Tpetra::CrsGraph* >(smartarg1->get()) : NULL; - arg2 = static_cast< long long >(*farg2); - tmpview3 = Teuchos::ArrayView(static_cast(farg3->data), farg3->size); - arg3 = &tmpview3; { // Make sure no unhandled exceptions exist before performing a new action - SWIG_check_unhandled_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::insertGlobalIndices(long long const,Teuchos::ArrayView< long long const > const &)");; + SWIG_check_unhandled_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::~CrsGraph()");; try { // Attempt the wrapped function call - (arg1)->insertGlobalIndices(arg2,(Teuchos::ArrayView< long long const > const &)*arg3); + (void)arg1; delete smartarg1; } catch (const std::range_error& e) { // Store a C++ exception - SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::insertGlobalIndices(long long const,Teuchos::ArrayView< long long const > const &)", SWIG_IndexError, e.what(), return ); + SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::~CrsGraph()", SWIG_IndexError, e.what(), return ); + } + catch (const std::exception& e) + { + // Store a C++ exception + SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::~CrsGraph()", SWIG_RuntimeError, e.what(), return ); + } + catch (...) + { + SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::~CrsGraph()", SWIG_UnknownError, "An unknown exception occurred", return ); + } + } + +} + + +SWIGEXPORT void _wrap_TpetraCrsGraph_swap(SwigClassWrapper const *farg1, SwigClassWrapper const *farg2) { + Tpetra::CrsGraph< LO,GO,NO > *arg1 = (Tpetra::CrsGraph< LO,GO,NO > *) 0 ; + Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode > *arg2 = 0 ; + Teuchos::RCP< Tpetra::CrsGraph< LO,GO,NO > > *smartarg1 ; + Teuchos::RCP< Tpetra::CrsGraph< LO,GO,NO > > *smartarg2 ; + + smartarg1 = static_cast< Teuchos::RCP< Tpetra::CrsGraph >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::CrsGraph* >(smartarg1->get()) : NULL; + SWIG_check_sp_nonnull(farg2, "Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode > *", "TpetraCrsGraph", "Tpetra::CrsGraph< LO,GO,NO >::swap(Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode > &)", return ) + smartarg2 = static_cast< Teuchos::RCP< Tpetra::CrsGraph >* >(farg2->cptr); + arg2 = const_cast< Tpetra::CrsGraph* >(smartarg2->get()); + { + // Make sure no unhandled exceptions exist before performing a new action + SWIG_check_unhandled_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::swap(Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode > &)");; + try + { + // Attempt the wrapped function call + (arg1)->swap(*arg2); + } + catch (const std::range_error& e) + { + // Store a C++ exception + SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::swap(Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode > &)", SWIG_IndexError, e.what(), return ); + } + catch (const std::exception& e) + { + // Store a C++ exception + SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::swap(Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode > &)", SWIG_RuntimeError, e.what(), return ); + } + catch (...) + { + SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::swap(Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode > &)", SWIG_UnknownError, "An unknown exception occurred", return ); + } + } + +} + + +SWIGEXPORT int _wrap_TpetraCrsGraph_isIdenticalTo(SwigClassWrapper const *farg1, SwigClassWrapper const *farg2) { + int fresult ; + Tpetra::CrsGraph< LO,GO,NO > *arg1 = (Tpetra::CrsGraph< LO,GO,NO > *) 0 ; + Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode > *arg2 = 0 ; + Teuchos::RCP< Tpetra::CrsGraph< LO,GO,NO > const > *smartarg1 ; + Teuchos::RCP< Tpetra::CrsGraph< LO,GO,NO > const > *smartarg2 ; + bool result; + + smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::CrsGraph* >(smartarg1->get()) : NULL; + SWIG_check_sp_nonnull(farg2, "Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode > *", "TpetraCrsGraph", "Tpetra::CrsGraph< LO,GO,NO >::isIdenticalTo(Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &) const", return 0) + smartarg2 = static_cast< Teuchos::RCP >* >(farg2->cptr); + arg2 = const_cast< Tpetra::CrsGraph* >(smartarg2->get()); + { + // Make sure no unhandled exceptions exist before performing a new action + SWIG_check_unhandled_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::isIdenticalTo(Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &) const");; + try + { + // Attempt the wrapped function call + result = (bool)((Tpetra::CrsGraph< LO,GO,NO > const *)arg1)->isIdenticalTo((Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &)*arg2); + } + catch (const std::range_error& e) + { + // Store a C++ exception + SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::isIdenticalTo(Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &) const", SWIG_IndexError, e.what(), return 0); + } + catch (const std::exception& e) + { + // Store a C++ exception + SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::isIdenticalTo(Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &) const", SWIG_RuntimeError, e.what(), return 0); + } + catch (...) + { + SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::isIdenticalTo(Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &) const", SWIG_UnknownError, "An unknown exception occurred", return 0); + } + } + fresult = (result ? 1 : 0); + return fresult; +} + + +SWIGEXPORT void _wrap_TpetraCrsGraph_setParameterList(SwigClassWrapper const *farg1, SwigClassWrapper const *farg2) { + Tpetra::CrsGraph< LO,GO,NO > *arg1 = (Tpetra::CrsGraph< LO,GO,NO > *) 0 ; + Teuchos::RCP< Teuchos::ParameterList > *arg2 = 0 ; + Teuchos::RCP< Tpetra::CrsGraph< LO,GO,NO > > *smartarg1 ; + Teuchos::RCP< Teuchos::ParameterList > tempnull2 ; + + smartarg1 = static_cast< Teuchos::RCP< Tpetra::CrsGraph >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::CrsGraph* >(smartarg1->get()) : NULL; + arg2 = farg2->cptr ? static_cast< Teuchos::RCP< Teuchos::ParameterList > * >(farg2->cptr) : &tempnull2; + { + // Make sure no unhandled exceptions exist before performing a new action + SWIG_check_unhandled_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::setParameterList(Teuchos::RCP< Teuchos::ParameterList > const &)");; + try + { + // Attempt the wrapped function call + (arg1)->setParameterList((Teuchos::RCP< Teuchos::ParameterList > const &)*arg2); + } + catch (const std::range_error& e) + { + // Store a C++ exception + SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::setParameterList(Teuchos::RCP< Teuchos::ParameterList > const &)", SWIG_IndexError, e.what(), return ); + } + catch (const std::exception& e) + { + // Store a C++ exception + SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::setParameterList(Teuchos::RCP< Teuchos::ParameterList > const &)", SWIG_RuntimeError, e.what(), return ); + } + catch (...) + { + SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::setParameterList(Teuchos::RCP< Teuchos::ParameterList > const &)", SWIG_UnknownError, "An unknown exception occurred", return ); + } + } + +} + + +SWIGEXPORT SwigClassWrapper _wrap_TpetraCrsGraph_getValidParameters(SwigClassWrapper const *farg1) { + SwigClassWrapper fresult ; + Tpetra::CrsGraph< LO,GO,NO > *arg1 = (Tpetra::CrsGraph< LO,GO,NO > *) 0 ; + Teuchos::RCP< Tpetra::CrsGraph< LO,GO,NO > const > *smartarg1 ; + Teuchos::RCP< Teuchos::ParameterList const > result; + + smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::CrsGraph* >(smartarg1->get()) : NULL; + { + // Make sure no unhandled exceptions exist before performing a new action + SWIG_check_unhandled_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::getValidParameters() const");; + try + { + // Attempt the wrapped function call + result = ((Tpetra::CrsGraph< LO,GO,NO > const *)arg1)->getValidParameters(); + } + catch (const std::range_error& e) + { + // Store a C++ exception + SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::getValidParameters() const", SWIG_IndexError, e.what(), return SwigClassWrapper_uninitialized()); + } + catch (const std::exception& e) + { + // Store a C++ exception + SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::getValidParameters() const", SWIG_RuntimeError, e.what(), return SwigClassWrapper_uninitialized()); + } + catch (...) + { + SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::getValidParameters() const", SWIG_UnknownError, "An unknown exception occurred", return SwigClassWrapper_uninitialized()); + } + } + fresult.cptr = (new Teuchos::RCP(static_cast< const Teuchos::RCP& >(result))); + fresult.mem = SWIG_MOVE; + return fresult; +} + + +SWIGEXPORT void _wrap_TpetraCrsGraph_insertGlobalIndices__SWIG_0(SwigClassWrapper const *farg1, long long const *farg2, SwigArrayWrapper *farg3) { + Tpetra::CrsGraph< LO,GO,NO > *arg1 = (Tpetra::CrsGraph< LO,GO,NO > *) 0 ; + long long arg2 ; + Teuchos::ArrayView< long long const > *arg3 = 0 ; + Teuchos::RCP< Tpetra::CrsGraph< LO,GO,NO > > *smartarg1 ; + Teuchos::ArrayView< long long const > tmpview3 ; + + smartarg1 = static_cast< Teuchos::RCP< Tpetra::CrsGraph >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::CrsGraph* >(smartarg1->get()) : NULL; + arg2 = static_cast< long long >(*farg2); + tmpview3 = Teuchos::ArrayView(static_cast(farg3->data), farg3->size); + arg3 = &tmpview3; + { + // Make sure no unhandled exceptions exist before performing a new action + SWIG_check_unhandled_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::insertGlobalIndices(long long const,Teuchos::ArrayView< long long const > const &)");; + try + { + // Attempt the wrapped function call + (arg1)->insertGlobalIndices(arg2,(Teuchos::ArrayView< long long const > const &)*arg3); + } + catch (const std::range_error& e) + { + // Store a C++ exception + SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::insertGlobalIndices(long long const,Teuchos::ArrayView< long long const > const &)", SWIG_IndexError, e.what(), return ); } catch (const std::exception& e) { @@ -9560,639 +9903,550 @@ SWIGEXPORT void _wrap_TpetraCrsGraph_computeGlobalConstants(SwigClassWrapper con } -SWIGEXPORT SwigClassWrapper _wrap_new_TpetraCrsGraph__SWIG_6(SwigClassWrapper const *farg1, SwigArrayWrapper *farg2, int const *farg3, SwigClassWrapper const *farg4) { - SwigClassWrapper fresult ; - Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > *arg1 = 0 ; - Teuchos::ArrayView< std::size_t const > arg2 ; - Tpetra::ProfileType arg3 ; - Teuchos::RCP< Teuchos::ParameterList > *arg4 = 0 ; - Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > tempnull1 ; - Teuchos::RCP< Teuchos::ParameterList > tempnull4 ; - Tpetra::CrsGraph< LO,GO,NO > *result = 0 ; +SWIGEXPORT void _wrap_TpetraCrsGraph_getNodeRowPtrs(SwigClassWrapper const *farg1, SwigArrayWrapper *farg2) { + Tpetra::CrsGraph< LO,GO,NO > *arg1 = (Tpetra::CrsGraph< LO,GO,NO > *) 0 ; + Teuchos::ArrayView< std::size_t > arg2 ; + Teuchos::RCP< Tpetra::CrsGraph< LO,GO,NO > const > *smartarg1 ; - arg1 = farg1->cptr ? static_cast< Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg1->cptr) : &tempnull1; - arg2 = Teuchos::ArrayView(static_cast(farg2->data), farg2->size); - arg3 = static_cast< Tpetra::ProfileType >(*farg3); - arg4 = farg4->cptr ? static_cast< Teuchos::RCP< Teuchos::ParameterList > * >(farg4->cptr) : &tempnull4; + smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::CrsGraph* >(smartarg1->get()) : NULL; + arg2 = Teuchos::ArrayView(static_cast(farg2->data), farg2->size); { // Make sure no unhandled exceptions exist before performing a new action - SWIG_check_unhandled_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::CrsGraph(Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::ArrayView< std::size_t const >,Tpetra::ProfileType const,Teuchos::RCP< Teuchos::ParameterList > const &)");; + SWIG_check_unhandled_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::getNodeRowPtrs(Teuchos::ArrayView< std::size_t >) const");; try { // Attempt the wrapped function call - result = (Tpetra::CrsGraph< LO,GO,NO > *)new_Tpetra_CrsGraph_Sl_LO_Sc_GO_Sc_NO_Sg___SWIG_6((Teuchos::RCP< ::Tpetra::Map< int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const > const &)*arg1,arg2,arg3,(Teuchos::RCP< Teuchos::ParameterList > const &)*arg4); + Tpetra_CrsGraph_Sl_LO_Sc_GO_Sc_NO_Sg__getNodeRowPtrs((Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const *)arg1,arg2); } catch (const std::range_error& e) { // Store a C++ exception - SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::CrsGraph(Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::ArrayView< std::size_t const >,Tpetra::ProfileType const,Teuchos::RCP< Teuchos::ParameterList > const &)", SWIG_IndexError, e.what(), return SwigClassWrapper_uninitialized()); + SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::getNodeRowPtrs(Teuchos::ArrayView< std::size_t >) const", SWIG_IndexError, e.what(), return ); } catch (const std::exception& e) { // Store a C++ exception - SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::CrsGraph(Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::ArrayView< std::size_t const >,Tpetra::ProfileType const,Teuchos::RCP< Teuchos::ParameterList > const &)", SWIG_RuntimeError, e.what(), return SwigClassWrapper_uninitialized()); + SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::getNodeRowPtrs(Teuchos::ArrayView< std::size_t >) const", SWIG_RuntimeError, e.what(), return ); } catch (...) { - SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::CrsGraph(Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::ArrayView< std::size_t const >,Tpetra::ProfileType const,Teuchos::RCP< Teuchos::ParameterList > const &)", SWIG_UnknownError, "An unknown exception occurred", return SwigClassWrapper_uninitialized()); + SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::getNodeRowPtrs(Teuchos::ArrayView< std::size_t >) const", SWIG_UnknownError, "An unknown exception occurred", return ); } } - fresult.cptr = result ? new Teuchos::RCP< Tpetra::CrsGraph >(result SWIG_NO_NULL_DELETER_1) : NULL; - fresult.mem = SWIG_MOVE; - return fresult; + } -SWIGEXPORT SwigClassWrapper _wrap_new_TpetraCrsGraph__SWIG_7(SwigClassWrapper const *farg1, SwigArrayWrapper *farg2, int const *farg3) { - SwigClassWrapper fresult ; - Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > *arg1 = 0 ; - Teuchos::ArrayView< std::size_t const > arg2 ; - Tpetra::ProfileType arg3 ; - Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > tempnull1 ; - Tpetra::CrsGraph< LO,GO,NO > *result = 0 ; +SWIGEXPORT void _wrap_TpetraCrsGraph_getNodePackedIndices(SwigClassWrapper const *farg1, SwigArrayWrapper *farg2) { + Tpetra::CrsGraph< LO,GO,NO > *arg1 = (Tpetra::CrsGraph< LO,GO,NO > *) 0 ; + Teuchos::ArrayView< std::size_t > arg2 ; + Teuchos::RCP< Tpetra::CrsGraph< LO,GO,NO > const > *smartarg1 ; - arg1 = farg1->cptr ? static_cast< Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg1->cptr) : &tempnull1; - arg2 = Teuchos::ArrayView(static_cast(farg2->data), farg2->size); - arg3 = static_cast< Tpetra::ProfileType >(*farg3); + smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::CrsGraph* >(smartarg1->get()) : NULL; + arg2 = Teuchos::ArrayView(static_cast(farg2->data), farg2->size); { // Make sure no unhandled exceptions exist before performing a new action - SWIG_check_unhandled_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::CrsGraph(Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::ArrayView< std::size_t const >,Tpetra::ProfileType const)");; + SWIG_check_unhandled_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::getNodePackedIndices(Teuchos::ArrayView< std::size_t >) const");; try { // Attempt the wrapped function call - result = (Tpetra::CrsGraph< LO,GO,NO > *)new_Tpetra_CrsGraph_Sl_LO_Sc_GO_Sc_NO_Sg___SWIG_6((Teuchos::RCP< ::Tpetra::Map< int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const > const &)*arg1,arg2,arg3); + Tpetra_CrsGraph_Sl_LO_Sc_GO_Sc_NO_Sg__getNodePackedIndices((Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const *)arg1,arg2); } catch (const std::range_error& e) { // Store a C++ exception - SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::CrsGraph(Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::ArrayView< std::size_t const >,Tpetra::ProfileType const)", SWIG_IndexError, e.what(), return SwigClassWrapper_uninitialized()); + SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::getNodePackedIndices(Teuchos::ArrayView< std::size_t >) const", SWIG_IndexError, e.what(), return ); } catch (const std::exception& e) { // Store a C++ exception - SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::CrsGraph(Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::ArrayView< std::size_t const >,Tpetra::ProfileType const)", SWIG_RuntimeError, e.what(), return SwigClassWrapper_uninitialized()); + SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::getNodePackedIndices(Teuchos::ArrayView< std::size_t >) const", SWIG_RuntimeError, e.what(), return ); } catch (...) { - SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::CrsGraph(Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::ArrayView< std::size_t const >,Tpetra::ProfileType const)", SWIG_UnknownError, "An unknown exception occurred", return SwigClassWrapper_uninitialized()); + SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::getNodePackedIndices(Teuchos::ArrayView< std::size_t >) const", SWIG_UnknownError, "An unknown exception occurred", return ); } } - fresult.cptr = result ? new Teuchos::RCP< Tpetra::CrsGraph >(result SWIG_NO_NULL_DELETER_1) : NULL; - fresult.mem = SWIG_MOVE; - return fresult; + } -SWIGEXPORT SwigClassWrapper _wrap_new_TpetraCrsGraph__SWIG_8(SwigClassWrapper const *farg1, SwigArrayWrapper *farg2) { - SwigClassWrapper fresult ; - Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > *arg1 = 0 ; - Teuchos::ArrayView< std::size_t const > arg2 ; - Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > tempnull1 ; - Tpetra::CrsGraph< LO,GO,NO > *result = 0 ; +SWIGEXPORT void _wrap_TpetraCrsGraph_doImport__SWIG_0(SwigClassWrapper const *farg1, SwigClassWrapper const *farg2, SwigClassWrapper const *farg3, int const *farg4) { + Tpetra::CrsGraph< LO,GO,NO > *arg1 = (Tpetra::CrsGraph< LO,GO,NO > *) 0 ; + Tpetra::CrsGraph< LO,GO,NO > *arg2 = 0 ; + Tpetra::Import< LO,GO,NO > *arg3 = 0 ; + Tpetra::CombineMode arg4 ; + Teuchos::RCP< Tpetra::CrsGraph< LO,GO,NO > > *smartarg1 ; + Teuchos::RCP< Tpetra::CrsGraph< LO,GO,NO > const > *smartarg2 ; + Teuchos::RCP< Tpetra::Import< LO,GO,NO > const > *smartarg3 ; - arg1 = farg1->cptr ? static_cast< Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg1->cptr) : &tempnull1; - arg2 = Teuchos::ArrayView(static_cast(farg2->data), farg2->size); - { - // Make sure no unhandled exceptions exist before performing a new action - SWIG_check_unhandled_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::CrsGraph(Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::ArrayView< std::size_t const >)");; - try + smartarg1 = static_cast< Teuchos::RCP< Tpetra::CrsGraph >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::CrsGraph* >(smartarg1->get()) : NULL; + SWIG_check_sp_nonnull(farg2, "Tpetra::CrsGraph< LO,GO,NO > *", "TpetraCrsGraph", "Tpetra::CrsGraph< LO,GO,NO >::doImport(Tpetra::CrsGraph< LO,GO,NO > const &,Tpetra::Import< LO,GO,NO > const &,Tpetra::CombineMode)", return ) + smartarg2 = static_cast< Teuchos::RCP >* >(farg2->cptr); + arg2 = const_cast< Tpetra::CrsGraph* >(smartarg2->get()); + SWIG_check_sp_nonnull(farg3, "Tpetra::Import< LO,GO,NO > *", "TpetraImport", "Tpetra::CrsGraph< LO,GO,NO >::doImport(Tpetra::CrsGraph< LO,GO,NO > const &,Tpetra::Import< LO,GO,NO > const &,Tpetra::CombineMode)", return ) + smartarg3 = static_cast< Teuchos::RCP >* >(farg3->cptr); + arg3 = const_cast< Tpetra::Import* >(smartarg3->get()); + arg4 = static_cast< Tpetra::CombineMode >(*farg4); + { + // Make sure no unhandled exceptions exist before performing a new action + SWIG_check_unhandled_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::doImport(Tpetra::CrsGraph< LO,GO,NO > const &,Tpetra::Import< LO,GO,NO > const &,Tpetra::CombineMode)");; + try { // Attempt the wrapped function call - result = (Tpetra::CrsGraph< LO,GO,NO > *)new_Tpetra_CrsGraph_Sl_LO_Sc_GO_Sc_NO_Sg___SWIG_6((Teuchos::RCP< ::Tpetra::Map< int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const > const &)*arg1,arg2); + Tpetra_CrsGraph_Sl_LO_Sc_GO_Sc_NO_Sg__doImport__SWIG_0(arg1,(Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &)*arg2,(Tpetra::Import< int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &)*arg3,arg4); } catch (const std::range_error& e) { // Store a C++ exception - SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::CrsGraph(Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::ArrayView< std::size_t const >)", SWIG_IndexError, e.what(), return SwigClassWrapper_uninitialized()); + SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::doImport(Tpetra::CrsGraph< LO,GO,NO > const &,Tpetra::Import< LO,GO,NO > const &,Tpetra::CombineMode)", SWIG_IndexError, e.what(), return ); } catch (const std::exception& e) { // Store a C++ exception - SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::CrsGraph(Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::ArrayView< std::size_t const >)", SWIG_RuntimeError, e.what(), return SwigClassWrapper_uninitialized()); + SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::doImport(Tpetra::CrsGraph< LO,GO,NO > const &,Tpetra::Import< LO,GO,NO > const &,Tpetra::CombineMode)", SWIG_RuntimeError, e.what(), return ); } catch (...) { - SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::CrsGraph(Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::ArrayView< std::size_t const >)", SWIG_UnknownError, "An unknown exception occurred", return SwigClassWrapper_uninitialized()); + SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::doImport(Tpetra::CrsGraph< LO,GO,NO > const &,Tpetra::Import< LO,GO,NO > const &,Tpetra::CombineMode)", SWIG_UnknownError, "An unknown exception occurred", return ); } } - fresult.cptr = result ? new Teuchos::RCP< Tpetra::CrsGraph >(result SWIG_NO_NULL_DELETER_1) : NULL; - fresult.mem = SWIG_MOVE; - return fresult; + } -SWIGEXPORT SwigClassWrapper _wrap_new_TpetraCrsGraph__SWIG_9(SwigClassWrapper const *farg1, SwigClassWrapper const *farg2, SwigArrayWrapper *farg3, int const *farg4, SwigClassWrapper const *farg5) { - SwigClassWrapper fresult ; - Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > *arg1 = 0 ; - Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > *arg2 = 0 ; - Teuchos::ArrayView< std::size_t const > arg3 ; - Tpetra::ProfileType arg4 ; - Teuchos::RCP< Teuchos::ParameterList > *arg5 = 0 ; - Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > tempnull1 ; - Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > tempnull2 ; - Teuchos::RCP< Teuchos::ParameterList > tempnull5 ; - Tpetra::CrsGraph< LO,GO,NO > *result = 0 ; +SWIGEXPORT void _wrap_TpetraCrsGraph_doImport__SWIG_1(SwigClassWrapper const *farg1, SwigClassWrapper const *farg2, SwigClassWrapper const *farg3, int const *farg4) { + Tpetra::CrsGraph< LO,GO,NO > *arg1 = (Tpetra::CrsGraph< LO,GO,NO > *) 0 ; + Tpetra::CrsGraph< LO,GO,NO > *arg2 = 0 ; + Tpetra::Export< LO,GO,NO > *arg3 = 0 ; + Tpetra::CombineMode arg4 ; + Teuchos::RCP< Tpetra::CrsGraph< LO,GO,NO > > *smartarg1 ; + Teuchos::RCP< Tpetra::CrsGraph< LO,GO,NO > const > *smartarg2 ; + Teuchos::RCP< Tpetra::Export< LO,GO,NO > const > *smartarg3 ; - arg1 = farg1->cptr ? static_cast< Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg1->cptr) : &tempnull1; - arg2 = farg2->cptr ? static_cast< Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg2->cptr) : &tempnull2; - arg3 = Teuchos::ArrayView(static_cast(farg3->data), farg3->size); - arg4 = static_cast< Tpetra::ProfileType >(*farg4); - arg5 = farg5->cptr ? static_cast< Teuchos::RCP< Teuchos::ParameterList > * >(farg5->cptr) : &tempnull5; + smartarg1 = static_cast< Teuchos::RCP< Tpetra::CrsGraph >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::CrsGraph* >(smartarg1->get()) : NULL; + SWIG_check_sp_nonnull(farg2, "Tpetra::CrsGraph< LO,GO,NO > *", "TpetraCrsGraph", "Tpetra::CrsGraph< LO,GO,NO >::doImport(Tpetra::CrsGraph< LO,GO,NO > const &,Tpetra::Export< LO,GO,NO > const &,Tpetra::CombineMode)", return ) + smartarg2 = static_cast< Teuchos::RCP >* >(farg2->cptr); + arg2 = const_cast< Tpetra::CrsGraph* >(smartarg2->get()); + SWIG_check_sp_nonnull(farg3, "Tpetra::Export< LO,GO,NO > *", "TpetraExport", "Tpetra::CrsGraph< LO,GO,NO >::doImport(Tpetra::CrsGraph< LO,GO,NO > const &,Tpetra::Export< LO,GO,NO > const &,Tpetra::CombineMode)", return ) + smartarg3 = static_cast< Teuchos::RCP >* >(farg3->cptr); + arg3 = const_cast< Tpetra::Export* >(smartarg3->get()); + arg4 = static_cast< Tpetra::CombineMode >(*farg4); { // Make sure no unhandled exceptions exist before performing a new action - SWIG_check_unhandled_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::CrsGraph(Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::ArrayView< std::size_t const >,Tpetra::ProfileType const,Teuchos::RCP< Teuchos::ParameterList > const &)");; + SWIG_check_unhandled_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::doImport(Tpetra::CrsGraph< LO,GO,NO > const &,Tpetra::Export< LO,GO,NO > const &,Tpetra::CombineMode)");; try { // Attempt the wrapped function call - result = (Tpetra::CrsGraph< LO,GO,NO > *)new_Tpetra_CrsGraph_Sl_LO_Sc_GO_Sc_NO_Sg___SWIG_9((Teuchos::RCP< ::Tpetra::Map< int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const > const &)*arg1,(Teuchos::RCP< ::Tpetra::Map< int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const > const &)*arg2,arg3,arg4,(Teuchos::RCP< Teuchos::ParameterList > const &)*arg5); + Tpetra_CrsGraph_Sl_LO_Sc_GO_Sc_NO_Sg__doImport__SWIG_1(arg1,(Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &)*arg2,(Tpetra::Export< int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &)*arg3,arg4); } catch (const std::range_error& e) { // Store a C++ exception - SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::CrsGraph(Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::ArrayView< std::size_t const >,Tpetra::ProfileType const,Teuchos::RCP< Teuchos::ParameterList > const &)", SWIG_IndexError, e.what(), return SwigClassWrapper_uninitialized()); + SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::doImport(Tpetra::CrsGraph< LO,GO,NO > const &,Tpetra::Export< LO,GO,NO > const &,Tpetra::CombineMode)", SWIG_IndexError, e.what(), return ); } catch (const std::exception& e) { // Store a C++ exception - SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::CrsGraph(Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::ArrayView< std::size_t const >,Tpetra::ProfileType const,Teuchos::RCP< Teuchos::ParameterList > const &)", SWIG_RuntimeError, e.what(), return SwigClassWrapper_uninitialized()); + SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::doImport(Tpetra::CrsGraph< LO,GO,NO > const &,Tpetra::Export< LO,GO,NO > const &,Tpetra::CombineMode)", SWIG_RuntimeError, e.what(), return ); } catch (...) { - SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::CrsGraph(Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::ArrayView< std::size_t const >,Tpetra::ProfileType const,Teuchos::RCP< Teuchos::ParameterList > const &)", SWIG_UnknownError, "An unknown exception occurred", return SwigClassWrapper_uninitialized()); + SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::doImport(Tpetra::CrsGraph< LO,GO,NO > const &,Tpetra::Export< LO,GO,NO > const &,Tpetra::CombineMode)", SWIG_UnknownError, "An unknown exception occurred", return ); } } - fresult.cptr = result ? new Teuchos::RCP< Tpetra::CrsGraph >(result SWIG_NO_NULL_DELETER_1) : NULL; - fresult.mem = SWIG_MOVE; - return fresult; + } -SWIGEXPORT SwigClassWrapper _wrap_new_TpetraCrsGraph__SWIG_10(SwigClassWrapper const *farg1, SwigClassWrapper const *farg2, SwigArrayWrapper *farg3, int const *farg4) { - SwigClassWrapper fresult ; - Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > *arg1 = 0 ; - Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > *arg2 = 0 ; - Teuchos::ArrayView< std::size_t const > arg3 ; - Tpetra::ProfileType arg4 ; - Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > tempnull1 ; - Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > tempnull2 ; - Tpetra::CrsGraph< LO,GO,NO > *result = 0 ; +SWIGEXPORT void _wrap_TpetraCrsGraph_doExport__SWIG_0(SwigClassWrapper const *farg1, SwigClassWrapper const *farg2, SwigClassWrapper const *farg3, int const *farg4) { + Tpetra::CrsGraph< LO,GO,NO > *arg1 = (Tpetra::CrsGraph< LO,GO,NO > *) 0 ; + Tpetra::CrsGraph< LO,GO,NO > *arg2 = 0 ; + Tpetra::Export< LO,GO,NO > *arg3 = 0 ; + Tpetra::CombineMode arg4 ; + Teuchos::RCP< Tpetra::CrsGraph< LO,GO,NO > > *smartarg1 ; + Teuchos::RCP< Tpetra::CrsGraph< LO,GO,NO > const > *smartarg2 ; + Teuchos::RCP< Tpetra::Export< LO,GO,NO > const > *smartarg3 ; - arg1 = farg1->cptr ? static_cast< Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg1->cptr) : &tempnull1; - arg2 = farg2->cptr ? static_cast< Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg2->cptr) : &tempnull2; - arg3 = Teuchos::ArrayView(static_cast(farg3->data), farg3->size); - arg4 = static_cast< Tpetra::ProfileType >(*farg4); + smartarg1 = static_cast< Teuchos::RCP< Tpetra::CrsGraph >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::CrsGraph* >(smartarg1->get()) : NULL; + SWIG_check_sp_nonnull(farg2, "Tpetra::CrsGraph< LO,GO,NO > *", "TpetraCrsGraph", "Tpetra::CrsGraph< LO,GO,NO >::doExport(Tpetra::CrsGraph< LO,GO,NO > const &,Tpetra::Export< LO,GO,NO > const &,Tpetra::CombineMode)", return ) + smartarg2 = static_cast< Teuchos::RCP >* >(farg2->cptr); + arg2 = const_cast< Tpetra::CrsGraph* >(smartarg2->get()); + SWIG_check_sp_nonnull(farg3, "Tpetra::Export< LO,GO,NO > *", "TpetraExport", "Tpetra::CrsGraph< LO,GO,NO >::doExport(Tpetra::CrsGraph< LO,GO,NO > const &,Tpetra::Export< LO,GO,NO > const &,Tpetra::CombineMode)", return ) + smartarg3 = static_cast< Teuchos::RCP >* >(farg3->cptr); + arg3 = const_cast< Tpetra::Export* >(smartarg3->get()); + arg4 = static_cast< Tpetra::CombineMode >(*farg4); { // Make sure no unhandled exceptions exist before performing a new action - SWIG_check_unhandled_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::CrsGraph(Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::ArrayView< std::size_t const >,Tpetra::ProfileType const)");; + SWIG_check_unhandled_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::doExport(Tpetra::CrsGraph< LO,GO,NO > const &,Tpetra::Export< LO,GO,NO > const &,Tpetra::CombineMode)");; try { // Attempt the wrapped function call - result = (Tpetra::CrsGraph< LO,GO,NO > *)new_Tpetra_CrsGraph_Sl_LO_Sc_GO_Sc_NO_Sg___SWIG_9((Teuchos::RCP< ::Tpetra::Map< int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const > const &)*arg1,(Teuchos::RCP< ::Tpetra::Map< int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const > const &)*arg2,arg3,arg4); + Tpetra_CrsGraph_Sl_LO_Sc_GO_Sc_NO_Sg__doExport__SWIG_0(arg1,(Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &)*arg2,(Tpetra::Export< int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &)*arg3,arg4); } catch (const std::range_error& e) { // Store a C++ exception - SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::CrsGraph(Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::ArrayView< std::size_t const >,Tpetra::ProfileType const)", SWIG_IndexError, e.what(), return SwigClassWrapper_uninitialized()); + SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::doExport(Tpetra::CrsGraph< LO,GO,NO > const &,Tpetra::Export< LO,GO,NO > const &,Tpetra::CombineMode)", SWIG_IndexError, e.what(), return ); } catch (const std::exception& e) { // Store a C++ exception - SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::CrsGraph(Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::ArrayView< std::size_t const >,Tpetra::ProfileType const)", SWIG_RuntimeError, e.what(), return SwigClassWrapper_uninitialized()); + SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::doExport(Tpetra::CrsGraph< LO,GO,NO > const &,Tpetra::Export< LO,GO,NO > const &,Tpetra::CombineMode)", SWIG_RuntimeError, e.what(), return ); } catch (...) { - SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::CrsGraph(Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::ArrayView< std::size_t const >,Tpetra::ProfileType const)", SWIG_UnknownError, "An unknown exception occurred", return SwigClassWrapper_uninitialized()); + SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::doExport(Tpetra::CrsGraph< LO,GO,NO > const &,Tpetra::Export< LO,GO,NO > const &,Tpetra::CombineMode)", SWIG_UnknownError, "An unknown exception occurred", return ); } } - fresult.cptr = result ? new Teuchos::RCP< Tpetra::CrsGraph >(result SWIG_NO_NULL_DELETER_1) : NULL; - fresult.mem = SWIG_MOVE; - return fresult; + } -SWIGEXPORT SwigClassWrapper _wrap_new_TpetraCrsGraph__SWIG_11(SwigClassWrapper const *farg1, SwigClassWrapper const *farg2, SwigArrayWrapper *farg3) { - SwigClassWrapper fresult ; - Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > *arg1 = 0 ; - Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > *arg2 = 0 ; - Teuchos::ArrayView< std::size_t const > arg3 ; - Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > tempnull1 ; - Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > tempnull2 ; - Tpetra::CrsGraph< LO,GO,NO > *result = 0 ; +SWIGEXPORT void _wrap_TpetraCrsGraph_doExport__SWIG_1(SwigClassWrapper const *farg1, SwigClassWrapper const *farg2, SwigClassWrapper const *farg3, int const *farg4) { + Tpetra::CrsGraph< LO,GO,NO > *arg1 = (Tpetra::CrsGraph< LO,GO,NO > *) 0 ; + Tpetra::CrsGraph< LO,GO,NO > *arg2 = 0 ; + Tpetra::Import< LO,GO,NO > *arg3 = 0 ; + Tpetra::CombineMode arg4 ; + Teuchos::RCP< Tpetra::CrsGraph< LO,GO,NO > > *smartarg1 ; + Teuchos::RCP< Tpetra::CrsGraph< LO,GO,NO > const > *smartarg2 ; + Teuchos::RCP< Tpetra::Import< LO,GO,NO > const > *smartarg3 ; - arg1 = farg1->cptr ? static_cast< Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg1->cptr) : &tempnull1; - arg2 = farg2->cptr ? static_cast< Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg2->cptr) : &tempnull2; - arg3 = Teuchos::ArrayView(static_cast(farg3->data), farg3->size); + smartarg1 = static_cast< Teuchos::RCP< Tpetra::CrsGraph >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::CrsGraph* >(smartarg1->get()) : NULL; + SWIG_check_sp_nonnull(farg2, "Tpetra::CrsGraph< LO,GO,NO > *", "TpetraCrsGraph", "Tpetra::CrsGraph< LO,GO,NO >::doExport(Tpetra::CrsGraph< LO,GO,NO > const &,Tpetra::Import< LO,GO,NO > const &,Tpetra::CombineMode)", return ) + smartarg2 = static_cast< Teuchos::RCP >* >(farg2->cptr); + arg2 = const_cast< Tpetra::CrsGraph* >(smartarg2->get()); + SWIG_check_sp_nonnull(farg3, "Tpetra::Import< LO,GO,NO > *", "TpetraImport", "Tpetra::CrsGraph< LO,GO,NO >::doExport(Tpetra::CrsGraph< LO,GO,NO > const &,Tpetra::Import< LO,GO,NO > const &,Tpetra::CombineMode)", return ) + smartarg3 = static_cast< Teuchos::RCP >* >(farg3->cptr); + arg3 = const_cast< Tpetra::Import* >(smartarg3->get()); + arg4 = static_cast< Tpetra::CombineMode >(*farg4); { // Make sure no unhandled exceptions exist before performing a new action - SWIG_check_unhandled_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::CrsGraph(Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::ArrayView< std::size_t const >)");; + SWIG_check_unhandled_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::doExport(Tpetra::CrsGraph< LO,GO,NO > const &,Tpetra::Import< LO,GO,NO > const &,Tpetra::CombineMode)");; try { // Attempt the wrapped function call - result = (Tpetra::CrsGraph< LO,GO,NO > *)new_Tpetra_CrsGraph_Sl_LO_Sc_GO_Sc_NO_Sg___SWIG_9((Teuchos::RCP< ::Tpetra::Map< int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const > const &)*arg1,(Teuchos::RCP< ::Tpetra::Map< int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const > const &)*arg2,arg3); + Tpetra_CrsGraph_Sl_LO_Sc_GO_Sc_NO_Sg__doExport__SWIG_1(arg1,(Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &)*arg2,(Tpetra::Import< int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &)*arg3,arg4); } catch (const std::range_error& e) { // Store a C++ exception - SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::CrsGraph(Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::ArrayView< std::size_t const >)", SWIG_IndexError, e.what(), return SwigClassWrapper_uninitialized()); + SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::doExport(Tpetra::CrsGraph< LO,GO,NO > const &,Tpetra::Import< LO,GO,NO > const &,Tpetra::CombineMode)", SWIG_IndexError, e.what(), return ); } catch (const std::exception& e) { // Store a C++ exception - SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::CrsGraph(Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::ArrayView< std::size_t const >)", SWIG_RuntimeError, e.what(), return SwigClassWrapper_uninitialized()); + SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::doExport(Tpetra::CrsGraph< LO,GO,NO > const &,Tpetra::Import< LO,GO,NO > const &,Tpetra::CombineMode)", SWIG_RuntimeError, e.what(), return ); } catch (...) { - SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::CrsGraph(Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::ArrayView< std::size_t const >)", SWIG_UnknownError, "An unknown exception occurred", return SwigClassWrapper_uninitialized()); + SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::doExport(Tpetra::CrsGraph< LO,GO,NO > const &,Tpetra::Import< LO,GO,NO > const &,Tpetra::CombineMode)", SWIG_UnknownError, "An unknown exception occurred", return ); } } - fresult.cptr = result ? new Teuchos::RCP< Tpetra::CrsGraph >(result SWIG_NO_NULL_DELETER_1) : NULL; - fresult.mem = SWIG_MOVE; - return fresult; + } -SWIGEXPORT SwigClassWrapper _wrap_new_TpetraCrsGraph__SWIG_12(SwigClassWrapper const *farg1, SwigClassWrapper const *farg2, SwigArrayWrapper *farg3, SwigArrayWrapper *farg4, SwigClassWrapper const *farg5) { +SWIGEXPORT void _wrap_assign_TpetraCrsGraph(SwigClassWrapper * self, SwigClassWrapper const * other) { + typedef Teuchos::RCP< Tpetra::CrsGraph > swig_lhs_classtype; + SWIG_assign(swig_lhs_classtype, self, + swig_lhs_classtype, const_cast(other), + 0 | swig::IS_DESTR | swig::IS_COPY_CONSTR); +} + + +SWIGEXPORT SwigClassWrapper _wrap_new_TpetraCrsMatrix__SWIG_0(SwigClassWrapper const *farg1, size_t const *farg2, int const *farg3, SwigClassWrapper const *farg4) { SwigClassWrapper fresult ; - Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > *arg1 = 0 ; - Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > *arg2 = 0 ; - Teuchos::ArrayView< std::size_t > arg3 ; - Teuchos::ArrayView< LO > arg4 ; - Teuchos::RCP< Teuchos::ParameterList > *arg5 = 0 ; - Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > tempnull1 ; - Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > tempnull2 ; - Teuchos::RCP< Teuchos::ParameterList > tempnull5 ; - Tpetra::CrsGraph< LO,GO,NO > *result = 0 ; + Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > *arg1 = 0 ; + size_t arg2 ; + Tpetra::ProfileType arg3 ; + Teuchos::RCP< Teuchos::ParameterList > *arg4 = 0 ; + Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > tempnull1 ; + Teuchos::RCP< Teuchos::ParameterList > tempnull4 ; + Tpetra::CrsMatrix< SC,LO,GO,NO > *result = 0 ; - arg1 = farg1->cptr ? static_cast< Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg1->cptr) : &tempnull1; - arg2 = farg2->cptr ? static_cast< Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg2->cptr) : &tempnull2; - arg3 = Teuchos::ArrayView(static_cast(farg3->data), farg3->size); - arg4 = Teuchos::ArrayView(static_cast(farg4->data), farg4->size); - arg5 = farg5->cptr ? static_cast< Teuchos::RCP< Teuchos::ParameterList > * >(farg5->cptr) : &tempnull5; + arg1 = farg1->cptr ? static_cast< Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg1->cptr) : &tempnull1; + arg2 = static_cast< size_t >(*farg2); + arg3 = static_cast< Tpetra::ProfileType >(*farg3); + arg4 = farg4->cptr ? static_cast< Teuchos::RCP< Teuchos::ParameterList > * >(farg4->cptr) : &tempnull4; { // Make sure no unhandled exceptions exist before performing a new action - SWIG_check_unhandled_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::CrsGraph(Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::ArrayView< std::size_t >,Teuchos::ArrayView< LO >,Teuchos::RCP< Teuchos::ParameterList > const &)");; + SWIG_check_unhandled_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::CrsMatrix(Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,size_t,Tpetra::ProfileType,Teuchos::RCP< Teuchos::ParameterList > const &)");; try { // Attempt the wrapped function call - result = (Tpetra::CrsGraph< LO,GO,NO > *)new_Tpetra_CrsGraph_Sl_LO_Sc_GO_Sc_NO_Sg___SWIG_12((Teuchos::RCP< ::Tpetra::Map< int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const > const &)*arg1,(Teuchos::RCP< ::Tpetra::Map< int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const > const &)*arg2,arg3,arg4,(Teuchos::RCP< Teuchos::ParameterList > const &)*arg5); + result = (Tpetra::CrsMatrix< SC,LO,GO,NO > *)new Tpetra::CrsMatrix< SC,LO,GO,NO >((Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &)*arg1,arg2,arg3,(Teuchos::RCP< Teuchos::ParameterList > const &)*arg4); } catch (const std::range_error& e) { // Store a C++ exception - SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::CrsGraph(Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::ArrayView< std::size_t >,Teuchos::ArrayView< LO >,Teuchos::RCP< Teuchos::ParameterList > const &)", SWIG_IndexError, e.what(), return SwigClassWrapper_uninitialized()); + SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::CrsMatrix(Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,size_t,Tpetra::ProfileType,Teuchos::RCP< Teuchos::ParameterList > const &)", SWIG_IndexError, e.what(), return SwigClassWrapper_uninitialized()); } catch (const std::exception& e) { // Store a C++ exception - SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::CrsGraph(Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::ArrayView< std::size_t >,Teuchos::ArrayView< LO >,Teuchos::RCP< Teuchos::ParameterList > const &)", SWIG_RuntimeError, e.what(), return SwigClassWrapper_uninitialized()); + SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::CrsMatrix(Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,size_t,Tpetra::ProfileType,Teuchos::RCP< Teuchos::ParameterList > const &)", SWIG_RuntimeError, e.what(), return SwigClassWrapper_uninitialized()); } catch (...) { - SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::CrsGraph(Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::ArrayView< std::size_t >,Teuchos::ArrayView< LO >,Teuchos::RCP< Teuchos::ParameterList > const &)", SWIG_UnknownError, "An unknown exception occurred", return SwigClassWrapper_uninitialized()); + SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::CrsMatrix(Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,size_t,Tpetra::ProfileType,Teuchos::RCP< Teuchos::ParameterList > const &)", SWIG_UnknownError, "An unknown exception occurred", return SwigClassWrapper_uninitialized()); } } - fresult.cptr = result ? new Teuchos::RCP< Tpetra::CrsGraph >(result SWIG_NO_NULL_DELETER_1) : NULL; + fresult.cptr = result ? new Teuchos::RCP< Tpetra::CrsMatrix >(result SWIG_NO_NULL_DELETER_1) : NULL; fresult.mem = SWIG_MOVE; return fresult; } -SWIGEXPORT SwigClassWrapper _wrap_new_TpetraCrsGraph__SWIG_13(SwigClassWrapper const *farg1, SwigClassWrapper const *farg2, SwigArrayWrapper *farg3, SwigArrayWrapper *farg4) { +SWIGEXPORT SwigClassWrapper _wrap_new_TpetraCrsMatrix__SWIG_1(SwigClassWrapper const *farg1, size_t const *farg2, int const *farg3) { SwigClassWrapper fresult ; - Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > *arg1 = 0 ; - Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > *arg2 = 0 ; - Teuchos::ArrayView< std::size_t > arg3 ; - Teuchos::ArrayView< LO > arg4 ; - Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > tempnull1 ; - Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > tempnull2 ; - Tpetra::CrsGraph< LO,GO,NO > *result = 0 ; + Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > *arg1 = 0 ; + size_t arg2 ; + Tpetra::ProfileType arg3 ; + Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > tempnull1 ; + Tpetra::CrsMatrix< SC,LO,GO,NO > *result = 0 ; - arg1 = farg1->cptr ? static_cast< Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg1->cptr) : &tempnull1; - arg2 = farg2->cptr ? static_cast< Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg2->cptr) : &tempnull2; - arg3 = Teuchos::ArrayView(static_cast(farg3->data), farg3->size); - arg4 = Teuchos::ArrayView(static_cast(farg4->data), farg4->size); + arg1 = farg1->cptr ? static_cast< Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg1->cptr) : &tempnull1; + arg2 = static_cast< size_t >(*farg2); + arg3 = static_cast< Tpetra::ProfileType >(*farg3); { // Make sure no unhandled exceptions exist before performing a new action - SWIG_check_unhandled_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::CrsGraph(Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::ArrayView< std::size_t >,Teuchos::ArrayView< LO >)");; + SWIG_check_unhandled_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::CrsMatrix(Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,size_t,Tpetra::ProfileType)");; try { // Attempt the wrapped function call - result = (Tpetra::CrsGraph< LO,GO,NO > *)new_Tpetra_CrsGraph_Sl_LO_Sc_GO_Sc_NO_Sg___SWIG_12((Teuchos::RCP< ::Tpetra::Map< int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const > const &)*arg1,(Teuchos::RCP< ::Tpetra::Map< int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const > const &)*arg2,arg3,arg4); + result = (Tpetra::CrsMatrix< SC,LO,GO,NO > *)new Tpetra::CrsMatrix< SC,LO,GO,NO >((Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &)*arg1,arg2,arg3); } catch (const std::range_error& e) { // Store a C++ exception - SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::CrsGraph(Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::ArrayView< std::size_t >,Teuchos::ArrayView< LO >)", SWIG_IndexError, e.what(), return SwigClassWrapper_uninitialized()); + SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::CrsMatrix(Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,size_t,Tpetra::ProfileType)", SWIG_IndexError, e.what(), return SwigClassWrapper_uninitialized()); } catch (const std::exception& e) { // Store a C++ exception - SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::CrsGraph(Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::ArrayView< std::size_t >,Teuchos::ArrayView< LO >)", SWIG_RuntimeError, e.what(), return SwigClassWrapper_uninitialized()); + SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::CrsMatrix(Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,size_t,Tpetra::ProfileType)", SWIG_RuntimeError, e.what(), return SwigClassWrapper_uninitialized()); } catch (...) { - SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::CrsGraph(Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::ArrayView< std::size_t >,Teuchos::ArrayView< LO >)", SWIG_UnknownError, "An unknown exception occurred", return SwigClassWrapper_uninitialized()); + SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::CrsMatrix(Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,size_t,Tpetra::ProfileType)", SWIG_UnknownError, "An unknown exception occurred", return SwigClassWrapper_uninitialized()); } } - fresult.cptr = result ? new Teuchos::RCP< Tpetra::CrsGraph >(result SWIG_NO_NULL_DELETER_1) : NULL; + fresult.cptr = result ? new Teuchos::RCP< Tpetra::CrsMatrix >(result SWIG_NO_NULL_DELETER_1) : NULL; fresult.mem = SWIG_MOVE; return fresult; } -SWIGEXPORT void _wrap_TpetraCrsGraph_getNodeRowPtrs(SwigClassWrapper const *farg1, SwigArrayWrapper *farg2) { - Tpetra::CrsGraph< LO,GO,NO > *arg1 = (Tpetra::CrsGraph< LO,GO,NO > *) 0 ; - Teuchos::ArrayView< std::size_t > arg2 ; - Teuchos::RCP< Tpetra::CrsGraph< LO,GO,NO > const > *smartarg1 ; +SWIGEXPORT SwigClassWrapper _wrap_new_TpetraCrsMatrix__SWIG_2(SwigClassWrapper const *farg1, size_t const *farg2) { + SwigClassWrapper fresult ; + Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > *arg1 = 0 ; + size_t arg2 ; + Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > tempnull1 ; + Tpetra::CrsMatrix< SC,LO,GO,NO > *result = 0 ; - smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); - arg1 = smartarg1 ? const_cast< Tpetra::CrsGraph* >(smartarg1->get()) : NULL; - arg2 = Teuchos::ArrayView(static_cast(farg2->data), farg2->size); + arg1 = farg1->cptr ? static_cast< Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg1->cptr) : &tempnull1; + arg2 = static_cast< size_t >(*farg2); { // Make sure no unhandled exceptions exist before performing a new action - SWIG_check_unhandled_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::getNodeRowPtrs(Teuchos::ArrayView< std::size_t >) const");; + SWIG_check_unhandled_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::CrsMatrix(Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,size_t)");; try { // Attempt the wrapped function call - Tpetra_CrsGraph_Sl_LO_Sc_GO_Sc_NO_Sg__getNodeRowPtrs((Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const *)arg1,arg2); + result = (Tpetra::CrsMatrix< SC,LO,GO,NO > *)new Tpetra::CrsMatrix< SC,LO,GO,NO >((Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &)*arg1,arg2); } catch (const std::range_error& e) { // Store a C++ exception - SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::getNodeRowPtrs(Teuchos::ArrayView< std::size_t >) const", SWIG_IndexError, e.what(), return ); + SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::CrsMatrix(Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,size_t)", SWIG_IndexError, e.what(), return SwigClassWrapper_uninitialized()); } catch (const std::exception& e) { // Store a C++ exception - SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::getNodeRowPtrs(Teuchos::ArrayView< std::size_t >) const", SWIG_RuntimeError, e.what(), return ); + SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::CrsMatrix(Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,size_t)", SWIG_RuntimeError, e.what(), return SwigClassWrapper_uninitialized()); } catch (...) { - SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::getNodeRowPtrs(Teuchos::ArrayView< std::size_t >) const", SWIG_UnknownError, "An unknown exception occurred", return ); + SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::CrsMatrix(Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,size_t)", SWIG_UnknownError, "An unknown exception occurred", return SwigClassWrapper_uninitialized()); } } - + fresult.cptr = result ? new Teuchos::RCP< Tpetra::CrsMatrix >(result SWIG_NO_NULL_DELETER_1) : NULL; + fresult.mem = SWIG_MOVE; + return fresult; } -SWIGEXPORT void _wrap_TpetraCrsGraph_getNodePackedIndices(SwigClassWrapper const *farg1, SwigArrayWrapper *farg2) { - Tpetra::CrsGraph< LO,GO,NO > *arg1 = (Tpetra::CrsGraph< LO,GO,NO > *) 0 ; - Teuchos::ArrayView< std::size_t > arg2 ; - Teuchos::RCP< Tpetra::CrsGraph< LO,GO,NO > const > *smartarg1 ; +SWIGEXPORT SwigClassWrapper _wrap_new_TpetraCrsMatrix__SWIG_3(SwigClassWrapper const *farg1, SwigArrayWrapper *farg2, int const *farg3, SwigClassWrapper const *farg4) { + SwigClassWrapper fresult ; + Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > *arg1 = 0 ; + Teuchos::ArrayRCP< std::size_t const > *arg2 = 0 ; + Tpetra::ProfileType arg3 ; + Teuchos::RCP< Teuchos::ParameterList > *arg4 = 0 ; + Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > tempnull1 ; + Teuchos::ArrayRCP< unsigned long const > tmparr2 ; + Teuchos::RCP< Teuchos::ParameterList > tempnull4 ; + Tpetra::CrsMatrix< SC,LO,GO,NO > *result = 0 ; - smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); - arg1 = smartarg1 ? const_cast< Tpetra::CrsGraph* >(smartarg1->get()) : NULL; - arg2 = Teuchos::ArrayView(static_cast(farg2->data), farg2->size); + arg1 = farg1->cptr ? static_cast< Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg1->cptr) : &tempnull1; + tmparr2 = Teuchos::ArrayRCP(static_cast(farg2->data), 0, farg2->size, false, Teuchos::RCP_DISABLE_NODE_LOOKUP); + arg2 = &tmparr2; + arg3 = static_cast< Tpetra::ProfileType >(*farg3); + arg4 = farg4->cptr ? static_cast< Teuchos::RCP< Teuchos::ParameterList > * >(farg4->cptr) : &tempnull4; { // Make sure no unhandled exceptions exist before performing a new action - SWIG_check_unhandled_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::getNodePackedIndices(Teuchos::ArrayView< std::size_t >) const");; + SWIG_check_unhandled_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::CrsMatrix(Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::ArrayRCP< std::size_t const > const &,Tpetra::ProfileType,Teuchos::RCP< Teuchos::ParameterList > const &)");; try { // Attempt the wrapped function call - Tpetra_CrsGraph_Sl_LO_Sc_GO_Sc_NO_Sg__getNodePackedIndices((Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const *)arg1,arg2); + result = (Tpetra::CrsMatrix< SC,LO,GO,NO > *)new Tpetra::CrsMatrix< SC,LO,GO,NO >((Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &)*arg1,(Teuchos::ArrayRCP< std::size_t const > const &)*arg2,arg3,(Teuchos::RCP< Teuchos::ParameterList > const &)*arg4); } catch (const std::range_error& e) { // Store a C++ exception - SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::getNodePackedIndices(Teuchos::ArrayView< std::size_t >) const", SWIG_IndexError, e.what(), return ); + SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::CrsMatrix(Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::ArrayRCP< std::size_t const > const &,Tpetra::ProfileType,Teuchos::RCP< Teuchos::ParameterList > const &)", SWIG_IndexError, e.what(), return SwigClassWrapper_uninitialized()); } catch (const std::exception& e) { // Store a C++ exception - SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::getNodePackedIndices(Teuchos::ArrayView< std::size_t >) const", SWIG_RuntimeError, e.what(), return ); + SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::CrsMatrix(Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::ArrayRCP< std::size_t const > const &,Tpetra::ProfileType,Teuchos::RCP< Teuchos::ParameterList > const &)", SWIG_RuntimeError, e.what(), return SwigClassWrapper_uninitialized()); } catch (...) { - SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::getNodePackedIndices(Teuchos::ArrayView< std::size_t >) const", SWIG_UnknownError, "An unknown exception occurred", return ); + SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::CrsMatrix(Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::ArrayRCP< std::size_t const > const &,Tpetra::ProfileType,Teuchos::RCP< Teuchos::ParameterList > const &)", SWIG_UnknownError, "An unknown exception occurred", return SwigClassWrapper_uninitialized()); } } - + fresult.cptr = result ? new Teuchos::RCP< Tpetra::CrsMatrix >(result SWIG_NO_NULL_DELETER_1) : NULL; + fresult.mem = SWIG_MOVE; + return fresult; } -SWIGEXPORT void _wrap_TpetraCrsGraph_doImport__SWIG_0(SwigClassWrapper const *farg1, SwigClassWrapper const *farg2, SwigClassWrapper const *farg3, int const *farg4) { - Tpetra::CrsGraph< LO,GO,NO > *arg1 = (Tpetra::CrsGraph< LO,GO,NO > *) 0 ; - Tpetra::CrsGraph< LO,GO,NO > *arg2 = 0 ; - Tpetra::Import< LO,GO,NO > *arg3 = 0 ; - Tpetra::CombineMode arg4 ; - Teuchos::RCP< Tpetra::CrsGraph< LO,GO,NO > > *smartarg1 ; - Teuchos::RCP< Tpetra::CrsGraph< LO,GO,NO > const > *smartarg2 ; - Teuchos::RCP< Tpetra::Import< LO,GO,NO > const > *smartarg3 ; - - smartarg1 = static_cast< Teuchos::RCP< Tpetra::CrsGraph >* >(farg1->cptr); - arg1 = smartarg1 ? const_cast< Tpetra::CrsGraph* >(smartarg1->get()) : NULL; - SWIG_check_sp_nonnull(farg2, "Tpetra::CrsGraph< LO,GO,NO > *", "TpetraCrsGraph", "Tpetra::CrsGraph< LO,GO,NO >::doImport(Tpetra::CrsGraph< LO,GO,NO > const &,Tpetra::Import< LO,GO,NO > const &,Tpetra::CombineMode)", return ) - smartarg2 = static_cast< Teuchos::RCP >* >(farg2->cptr); - arg2 = const_cast< Tpetra::CrsGraph* >(smartarg2->get()); - SWIG_check_sp_nonnull(farg3, "Tpetra::Import< LO,GO,NO > *", "TpetraImport", "Tpetra::CrsGraph< LO,GO,NO >::doImport(Tpetra::CrsGraph< LO,GO,NO > const &,Tpetra::Import< LO,GO,NO > const &,Tpetra::CombineMode)", return ) - smartarg3 = static_cast< Teuchos::RCP >* >(farg3->cptr); - arg3 = const_cast< Tpetra::Import* >(smartarg3->get()); - arg4 = static_cast< Tpetra::CombineMode >(*farg4); - { - // Make sure no unhandled exceptions exist before performing a new action - SWIG_check_unhandled_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::doImport(Tpetra::CrsGraph< LO,GO,NO > const &,Tpetra::Import< LO,GO,NO > const &,Tpetra::CombineMode)");; - try - { - // Attempt the wrapped function call - Tpetra_CrsGraph_Sl_LO_Sc_GO_Sc_NO_Sg__doImport__SWIG_0(arg1,(Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &)*arg2,(Tpetra::Import< int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &)*arg3,arg4); - } - catch (const std::range_error& e) - { - // Store a C++ exception - SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::doImport(Tpetra::CrsGraph< LO,GO,NO > const &,Tpetra::Import< LO,GO,NO > const &,Tpetra::CombineMode)", SWIG_IndexError, e.what(), return ); - } - catch (const std::exception& e) - { - // Store a C++ exception - SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::doImport(Tpetra::CrsGraph< LO,GO,NO > const &,Tpetra::Import< LO,GO,NO > const &,Tpetra::CombineMode)", SWIG_RuntimeError, e.what(), return ); - } - catch (...) - { - SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::doImport(Tpetra::CrsGraph< LO,GO,NO > const &,Tpetra::Import< LO,GO,NO > const &,Tpetra::CombineMode)", SWIG_UnknownError, "An unknown exception occurred", return ); - } - } - -} - - -SWIGEXPORT void _wrap_TpetraCrsGraph_doImport__SWIG_1(SwigClassWrapper const *farg1, SwigClassWrapper const *farg2, SwigClassWrapper const *farg3, int const *farg4) { - Tpetra::CrsGraph< LO,GO,NO > *arg1 = (Tpetra::CrsGraph< LO,GO,NO > *) 0 ; - Tpetra::CrsGraph< LO,GO,NO > *arg2 = 0 ; - Tpetra::Export< LO,GO,NO > *arg3 = 0 ; - Tpetra::CombineMode arg4 ; - Teuchos::RCP< Tpetra::CrsGraph< LO,GO,NO > > *smartarg1 ; - Teuchos::RCP< Tpetra::CrsGraph< LO,GO,NO > const > *smartarg2 ; - Teuchos::RCP< Tpetra::Export< LO,GO,NO > const > *smartarg3 ; - - smartarg1 = static_cast< Teuchos::RCP< Tpetra::CrsGraph >* >(farg1->cptr); - arg1 = smartarg1 ? const_cast< Tpetra::CrsGraph* >(smartarg1->get()) : NULL; - SWIG_check_sp_nonnull(farg2, "Tpetra::CrsGraph< LO,GO,NO > *", "TpetraCrsGraph", "Tpetra::CrsGraph< LO,GO,NO >::doImport(Tpetra::CrsGraph< LO,GO,NO > const &,Tpetra::Export< LO,GO,NO > const &,Tpetra::CombineMode)", return ) - smartarg2 = static_cast< Teuchos::RCP >* >(farg2->cptr); - arg2 = const_cast< Tpetra::CrsGraph* >(smartarg2->get()); - SWIG_check_sp_nonnull(farg3, "Tpetra::Export< LO,GO,NO > *", "TpetraExport", "Tpetra::CrsGraph< LO,GO,NO >::doImport(Tpetra::CrsGraph< LO,GO,NO > const &,Tpetra::Export< LO,GO,NO > const &,Tpetra::CombineMode)", return ) - smartarg3 = static_cast< Teuchos::RCP >* >(farg3->cptr); - arg3 = const_cast< Tpetra::Export* >(smartarg3->get()); - arg4 = static_cast< Tpetra::CombineMode >(*farg4); - { - // Make sure no unhandled exceptions exist before performing a new action - SWIG_check_unhandled_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::doImport(Tpetra::CrsGraph< LO,GO,NO > const &,Tpetra::Export< LO,GO,NO > const &,Tpetra::CombineMode)");; - try - { - // Attempt the wrapped function call - Tpetra_CrsGraph_Sl_LO_Sc_GO_Sc_NO_Sg__doImport__SWIG_1(arg1,(Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &)*arg2,(Tpetra::Export< int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &)*arg3,arg4); - } - catch (const std::range_error& e) - { - // Store a C++ exception - SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::doImport(Tpetra::CrsGraph< LO,GO,NO > const &,Tpetra::Export< LO,GO,NO > const &,Tpetra::CombineMode)", SWIG_IndexError, e.what(), return ); - } - catch (const std::exception& e) - { - // Store a C++ exception - SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::doImport(Tpetra::CrsGraph< LO,GO,NO > const &,Tpetra::Export< LO,GO,NO > const &,Tpetra::CombineMode)", SWIG_RuntimeError, e.what(), return ); - } - catch (...) - { - SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::doImport(Tpetra::CrsGraph< LO,GO,NO > const &,Tpetra::Export< LO,GO,NO > const &,Tpetra::CombineMode)", SWIG_UnknownError, "An unknown exception occurred", return ); - } - } - -} - - -SWIGEXPORT void _wrap_TpetraCrsGraph_doExport__SWIG_0(SwigClassWrapper const *farg1, SwigClassWrapper const *farg2, SwigClassWrapper const *farg3, int const *farg4) { - Tpetra::CrsGraph< LO,GO,NO > *arg1 = (Tpetra::CrsGraph< LO,GO,NO > *) 0 ; - Tpetra::CrsGraph< LO,GO,NO > *arg2 = 0 ; - Tpetra::Export< LO,GO,NO > *arg3 = 0 ; - Tpetra::CombineMode arg4 ; - Teuchos::RCP< Tpetra::CrsGraph< LO,GO,NO > > *smartarg1 ; - Teuchos::RCP< Tpetra::CrsGraph< LO,GO,NO > const > *smartarg2 ; - Teuchos::RCP< Tpetra::Export< LO,GO,NO > const > *smartarg3 ; +SWIGEXPORT SwigClassWrapper _wrap_new_TpetraCrsMatrix__SWIG_4(SwigClassWrapper const *farg1, SwigArrayWrapper *farg2, int const *farg3) { + SwigClassWrapper fresult ; + Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > *arg1 = 0 ; + Teuchos::ArrayRCP< std::size_t const > *arg2 = 0 ; + Tpetra::ProfileType arg3 ; + Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > tempnull1 ; + Teuchos::ArrayRCP< unsigned long const > tmparr2 ; + Tpetra::CrsMatrix< SC,LO,GO,NO > *result = 0 ; - smartarg1 = static_cast< Teuchos::RCP< Tpetra::CrsGraph >* >(farg1->cptr); - arg1 = smartarg1 ? const_cast< Tpetra::CrsGraph* >(smartarg1->get()) : NULL; - SWIG_check_sp_nonnull(farg2, "Tpetra::CrsGraph< LO,GO,NO > *", "TpetraCrsGraph", "Tpetra::CrsGraph< LO,GO,NO >::doExport(Tpetra::CrsGraph< LO,GO,NO > const &,Tpetra::Export< LO,GO,NO > const &,Tpetra::CombineMode)", return ) - smartarg2 = static_cast< Teuchos::RCP >* >(farg2->cptr); - arg2 = const_cast< Tpetra::CrsGraph* >(smartarg2->get()); - SWIG_check_sp_nonnull(farg3, "Tpetra::Export< LO,GO,NO > *", "TpetraExport", "Tpetra::CrsGraph< LO,GO,NO >::doExport(Tpetra::CrsGraph< LO,GO,NO > const &,Tpetra::Export< LO,GO,NO > const &,Tpetra::CombineMode)", return ) - smartarg3 = static_cast< Teuchos::RCP >* >(farg3->cptr); - arg3 = const_cast< Tpetra::Export* >(smartarg3->get()); - arg4 = static_cast< Tpetra::CombineMode >(*farg4); + arg1 = farg1->cptr ? static_cast< Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg1->cptr) : &tempnull1; + tmparr2 = Teuchos::ArrayRCP(static_cast(farg2->data), 0, farg2->size, false, Teuchos::RCP_DISABLE_NODE_LOOKUP); + arg2 = &tmparr2; + arg3 = static_cast< Tpetra::ProfileType >(*farg3); { // Make sure no unhandled exceptions exist before performing a new action - SWIG_check_unhandled_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::doExport(Tpetra::CrsGraph< LO,GO,NO > const &,Tpetra::Export< LO,GO,NO > const &,Tpetra::CombineMode)");; + SWIG_check_unhandled_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::CrsMatrix(Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::ArrayRCP< std::size_t const > const &,Tpetra::ProfileType)");; try { // Attempt the wrapped function call - Tpetra_CrsGraph_Sl_LO_Sc_GO_Sc_NO_Sg__doExport__SWIG_0(arg1,(Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &)*arg2,(Tpetra::Export< int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &)*arg3,arg4); + result = (Tpetra::CrsMatrix< SC,LO,GO,NO > *)new Tpetra::CrsMatrix< SC,LO,GO,NO >((Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &)*arg1,(Teuchos::ArrayRCP< std::size_t const > const &)*arg2,arg3); } catch (const std::range_error& e) { // Store a C++ exception - SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::doExport(Tpetra::CrsGraph< LO,GO,NO > const &,Tpetra::Export< LO,GO,NO > const &,Tpetra::CombineMode)", SWIG_IndexError, e.what(), return ); + SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::CrsMatrix(Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::ArrayRCP< std::size_t const > const &,Tpetra::ProfileType)", SWIG_IndexError, e.what(), return SwigClassWrapper_uninitialized()); } catch (const std::exception& e) { // Store a C++ exception - SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::doExport(Tpetra::CrsGraph< LO,GO,NO > const &,Tpetra::Export< LO,GO,NO > const &,Tpetra::CombineMode)", SWIG_RuntimeError, e.what(), return ); + SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::CrsMatrix(Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::ArrayRCP< std::size_t const > const &,Tpetra::ProfileType)", SWIG_RuntimeError, e.what(), return SwigClassWrapper_uninitialized()); } catch (...) { - SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::doExport(Tpetra::CrsGraph< LO,GO,NO > const &,Tpetra::Export< LO,GO,NO > const &,Tpetra::CombineMode)", SWIG_UnknownError, "An unknown exception occurred", return ); + SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::CrsMatrix(Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::ArrayRCP< std::size_t const > const &,Tpetra::ProfileType)", SWIG_UnknownError, "An unknown exception occurred", return SwigClassWrapper_uninitialized()); } } - + fresult.cptr = result ? new Teuchos::RCP< Tpetra::CrsMatrix >(result SWIG_NO_NULL_DELETER_1) : NULL; + fresult.mem = SWIG_MOVE; + return fresult; } -SWIGEXPORT void _wrap_TpetraCrsGraph_doExport__SWIG_1(SwigClassWrapper const *farg1, SwigClassWrapper const *farg2, SwigClassWrapper const *farg3, int const *farg4) { - Tpetra::CrsGraph< LO,GO,NO > *arg1 = (Tpetra::CrsGraph< LO,GO,NO > *) 0 ; - Tpetra::CrsGraph< LO,GO,NO > *arg2 = 0 ; - Tpetra::Import< LO,GO,NO > *arg3 = 0 ; - Tpetra::CombineMode arg4 ; - Teuchos::RCP< Tpetra::CrsGraph< LO,GO,NO > > *smartarg1 ; - Teuchos::RCP< Tpetra::CrsGraph< LO,GO,NO > const > *smartarg2 ; - Teuchos::RCP< Tpetra::Import< LO,GO,NO > const > *smartarg3 ; +SWIGEXPORT SwigClassWrapper _wrap_new_TpetraCrsMatrix__SWIG_5(SwigClassWrapper const *farg1, SwigArrayWrapper *farg2) { + SwigClassWrapper fresult ; + Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > *arg1 = 0 ; + Teuchos::ArrayRCP< std::size_t const > *arg2 = 0 ; + Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > tempnull1 ; + Teuchos::ArrayRCP< unsigned long const > tmparr2 ; + Tpetra::CrsMatrix< SC,LO,GO,NO > *result = 0 ; - smartarg1 = static_cast< Teuchos::RCP< Tpetra::CrsGraph >* >(farg1->cptr); - arg1 = smartarg1 ? const_cast< Tpetra::CrsGraph* >(smartarg1->get()) : NULL; - SWIG_check_sp_nonnull(farg2, "Tpetra::CrsGraph< LO,GO,NO > *", "TpetraCrsGraph", "Tpetra::CrsGraph< LO,GO,NO >::doExport(Tpetra::CrsGraph< LO,GO,NO > const &,Tpetra::Import< LO,GO,NO > const &,Tpetra::CombineMode)", return ) - smartarg2 = static_cast< Teuchos::RCP >* >(farg2->cptr); - arg2 = const_cast< Tpetra::CrsGraph* >(smartarg2->get()); - SWIG_check_sp_nonnull(farg3, "Tpetra::Import< LO,GO,NO > *", "TpetraImport", "Tpetra::CrsGraph< LO,GO,NO >::doExport(Tpetra::CrsGraph< LO,GO,NO > const &,Tpetra::Import< LO,GO,NO > const &,Tpetra::CombineMode)", return ) - smartarg3 = static_cast< Teuchos::RCP >* >(farg3->cptr); - arg3 = const_cast< Tpetra::Import* >(smartarg3->get()); - arg4 = static_cast< Tpetra::CombineMode >(*farg4); + arg1 = farg1->cptr ? static_cast< Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg1->cptr) : &tempnull1; + tmparr2 = Teuchos::ArrayRCP(static_cast(farg2->data), 0, farg2->size, false, Teuchos::RCP_DISABLE_NODE_LOOKUP); + arg2 = &tmparr2; { // Make sure no unhandled exceptions exist before performing a new action - SWIG_check_unhandled_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::doExport(Tpetra::CrsGraph< LO,GO,NO > const &,Tpetra::Import< LO,GO,NO > const &,Tpetra::CombineMode)");; + SWIG_check_unhandled_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::CrsMatrix(Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::ArrayRCP< std::size_t const > const &)");; try { // Attempt the wrapped function call - Tpetra_CrsGraph_Sl_LO_Sc_GO_Sc_NO_Sg__doExport__SWIG_1(arg1,(Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &)*arg2,(Tpetra::Import< int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &)*arg3,arg4); + result = (Tpetra::CrsMatrix< SC,LO,GO,NO > *)new Tpetra::CrsMatrix< SC,LO,GO,NO >((Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &)*arg1,(Teuchos::ArrayRCP< std::size_t const > const &)*arg2); } catch (const std::range_error& e) { // Store a C++ exception - SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::doExport(Tpetra::CrsGraph< LO,GO,NO > const &,Tpetra::Import< LO,GO,NO > const &,Tpetra::CombineMode)", SWIG_IndexError, e.what(), return ); + SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::CrsMatrix(Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::ArrayRCP< std::size_t const > const &)", SWIG_IndexError, e.what(), return SwigClassWrapper_uninitialized()); } catch (const std::exception& e) { // Store a C++ exception - SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::doExport(Tpetra::CrsGraph< LO,GO,NO > const &,Tpetra::Import< LO,GO,NO > const &,Tpetra::CombineMode)", SWIG_RuntimeError, e.what(), return ); + SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::CrsMatrix(Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::ArrayRCP< std::size_t const > const &)", SWIG_RuntimeError, e.what(), return SwigClassWrapper_uninitialized()); } catch (...) { - SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::doExport(Tpetra::CrsGraph< LO,GO,NO > const &,Tpetra::Import< LO,GO,NO > const &,Tpetra::CombineMode)", SWIG_UnknownError, "An unknown exception occurred", return ); + SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::CrsMatrix(Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::ArrayRCP< std::size_t const > const &)", SWIG_UnknownError, "An unknown exception occurred", return SwigClassWrapper_uninitialized()); } } - -} - - -SWIGEXPORT void _wrap_assign_TpetraCrsGraph(SwigClassWrapper * self, SwigClassWrapper const * other) { - typedef Teuchos::RCP< Tpetra::CrsGraph > swig_lhs_classtype; - SWIG_assign(swig_lhs_classtype, self, - swig_lhs_classtype, const_cast(other), - 0 | swig::IS_DESTR | swig::IS_COPY_CONSTR); + fresult.cptr = result ? new Teuchos::RCP< Tpetra::CrsMatrix >(result SWIG_NO_NULL_DELETER_1) : NULL; + fresult.mem = SWIG_MOVE; + return fresult; } -SWIGEXPORT SwigClassWrapper _wrap_new_TpetraCrsMatrix__SWIG_0(SwigClassWrapper const *farg1, size_t const *farg2, int const *farg3, SwigClassWrapper const *farg4) { +SWIGEXPORT SwigClassWrapper _wrap_new_TpetraCrsMatrix__SWIG_6(SwigClassWrapper const *farg1, SwigClassWrapper const *farg2, size_t const *farg3, int const *farg4, SwigClassWrapper const *farg5) { SwigClassWrapper fresult ; Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > *arg1 = 0 ; - size_t arg2 ; - Tpetra::ProfileType arg3 ; - Teuchos::RCP< Teuchos::ParameterList > *arg4 = 0 ; + Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > *arg2 = 0 ; + size_t arg3 ; + Tpetra::ProfileType arg4 ; + Teuchos::RCP< Teuchos::ParameterList > *arg5 = 0 ; Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > tempnull1 ; - Teuchos::RCP< Teuchos::ParameterList > tempnull4 ; + Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > tempnull2 ; + Teuchos::RCP< Teuchos::ParameterList > tempnull5 ; Tpetra::CrsMatrix< SC,LO,GO,NO > *result = 0 ; arg1 = farg1->cptr ? static_cast< Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg1->cptr) : &tempnull1; - arg2 = static_cast< size_t >(*farg2); - arg3 = static_cast< Tpetra::ProfileType >(*farg3); - arg4 = farg4->cptr ? static_cast< Teuchos::RCP< Teuchos::ParameterList > * >(farg4->cptr) : &tempnull4; + arg2 = farg2->cptr ? static_cast< Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg2->cptr) : &tempnull2; + arg3 = static_cast< size_t >(*farg3); + arg4 = static_cast< Tpetra::ProfileType >(*farg4); + arg5 = farg5->cptr ? static_cast< Teuchos::RCP< Teuchos::ParameterList > * >(farg5->cptr) : &tempnull5; { // Make sure no unhandled exceptions exist before performing a new action - SWIG_check_unhandled_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::CrsMatrix(Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,size_t,Tpetra::ProfileType,Teuchos::RCP< Teuchos::ParameterList > const &)");; + SWIG_check_unhandled_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::CrsMatrix(Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,size_t,Tpetra::ProfileType,Teuchos::RCP< Teuchos::ParameterList > const &)");; try { // Attempt the wrapped function call - result = (Tpetra::CrsMatrix< SC,LO,GO,NO > *)new Tpetra::CrsMatrix< SC,LO,GO,NO >((Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &)*arg1,arg2,arg3,(Teuchos::RCP< Teuchos::ParameterList > const &)*arg4); + result = (Tpetra::CrsMatrix< SC,LO,GO,NO > *)new Tpetra::CrsMatrix< SC,LO,GO,NO >((Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &)*arg1,(Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &)*arg2,arg3,arg4,(Teuchos::RCP< Teuchos::ParameterList > const &)*arg5); } catch (const std::range_error& e) { // Store a C++ exception - SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::CrsMatrix(Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,size_t,Tpetra::ProfileType,Teuchos::RCP< Teuchos::ParameterList > const &)", SWIG_IndexError, e.what(), return SwigClassWrapper_uninitialized()); + SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::CrsMatrix(Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,size_t,Tpetra::ProfileType,Teuchos::RCP< Teuchos::ParameterList > const &)", SWIG_IndexError, e.what(), return SwigClassWrapper_uninitialized()); } catch (const std::exception& e) { // Store a C++ exception - SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::CrsMatrix(Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,size_t,Tpetra::ProfileType,Teuchos::RCP< Teuchos::ParameterList > const &)", SWIG_RuntimeError, e.what(), return SwigClassWrapper_uninitialized()); + SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::CrsMatrix(Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,size_t,Tpetra::ProfileType,Teuchos::RCP< Teuchos::ParameterList > const &)", SWIG_RuntimeError, e.what(), return SwigClassWrapper_uninitialized()); } catch (...) { - SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::CrsMatrix(Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,size_t,Tpetra::ProfileType,Teuchos::RCP< Teuchos::ParameterList > const &)", SWIG_UnknownError, "An unknown exception occurred", return SwigClassWrapper_uninitialized()); + SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::CrsMatrix(Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,size_t,Tpetra::ProfileType,Teuchos::RCP< Teuchos::ParameterList > const &)", SWIG_UnknownError, "An unknown exception occurred", return SwigClassWrapper_uninitialized()); } } fresult.cptr = result ? new Teuchos::RCP< Tpetra::CrsMatrix >(result SWIG_NO_NULL_DELETER_1) : NULL; @@ -10201,38 +10455,41 @@ SWIGEXPORT SwigClassWrapper _wrap_new_TpetraCrsMatrix__SWIG_0(SwigClassWrapper c } -SWIGEXPORT SwigClassWrapper _wrap_new_TpetraCrsMatrix__SWIG_1(SwigClassWrapper const *farg1, size_t const *farg2, int const *farg3) { +SWIGEXPORT SwigClassWrapper _wrap_new_TpetraCrsMatrix__SWIG_7(SwigClassWrapper const *farg1, SwigClassWrapper const *farg2, size_t const *farg3, int const *farg4) { SwigClassWrapper fresult ; Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > *arg1 = 0 ; - size_t arg2 ; - Tpetra::ProfileType arg3 ; + Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > *arg2 = 0 ; + size_t arg3 ; + Tpetra::ProfileType arg4 ; Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > tempnull1 ; + Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > tempnull2 ; Tpetra::CrsMatrix< SC,LO,GO,NO > *result = 0 ; arg1 = farg1->cptr ? static_cast< Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg1->cptr) : &tempnull1; - arg2 = static_cast< size_t >(*farg2); - arg3 = static_cast< Tpetra::ProfileType >(*farg3); + arg2 = farg2->cptr ? static_cast< Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg2->cptr) : &tempnull2; + arg3 = static_cast< size_t >(*farg3); + arg4 = static_cast< Tpetra::ProfileType >(*farg4); { // Make sure no unhandled exceptions exist before performing a new action - SWIG_check_unhandled_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::CrsMatrix(Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,size_t,Tpetra::ProfileType)");; + SWIG_check_unhandled_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::CrsMatrix(Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,size_t,Tpetra::ProfileType)");; try { // Attempt the wrapped function call - result = (Tpetra::CrsMatrix< SC,LO,GO,NO > *)new Tpetra::CrsMatrix< SC,LO,GO,NO >((Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &)*arg1,arg2,arg3); + result = (Tpetra::CrsMatrix< SC,LO,GO,NO > *)new Tpetra::CrsMatrix< SC,LO,GO,NO >((Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &)*arg1,(Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &)*arg2,arg3,arg4); } catch (const std::range_error& e) { // Store a C++ exception - SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::CrsMatrix(Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,size_t,Tpetra::ProfileType)", SWIG_IndexError, e.what(), return SwigClassWrapper_uninitialized()); + SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::CrsMatrix(Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,size_t,Tpetra::ProfileType)", SWIG_IndexError, e.what(), return SwigClassWrapper_uninitialized()); } catch (const std::exception& e) { // Store a C++ exception - SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::CrsMatrix(Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,size_t,Tpetra::ProfileType)", SWIG_RuntimeError, e.what(), return SwigClassWrapper_uninitialized()); + SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::CrsMatrix(Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,size_t,Tpetra::ProfileType)", SWIG_RuntimeError, e.what(), return SwigClassWrapper_uninitialized()); } catch (...) { - SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::CrsMatrix(Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,size_t,Tpetra::ProfileType)", SWIG_UnknownError, "An unknown exception occurred", return SwigClassWrapper_uninitialized()); + SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::CrsMatrix(Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,size_t,Tpetra::ProfileType)", SWIG_UnknownError, "An unknown exception occurred", return SwigClassWrapper_uninitialized()); } } fresult.cptr = result ? new Teuchos::RCP< Tpetra::CrsMatrix >(result SWIG_NO_NULL_DELETER_1) : NULL; @@ -10241,36 +10498,39 @@ SWIGEXPORT SwigClassWrapper _wrap_new_TpetraCrsMatrix__SWIG_1(SwigClassWrapper c } -SWIGEXPORT SwigClassWrapper _wrap_new_TpetraCrsMatrix__SWIG_2(SwigClassWrapper const *farg1, size_t const *farg2) { +SWIGEXPORT SwigClassWrapper _wrap_new_TpetraCrsMatrix__SWIG_8(SwigClassWrapper const *farg1, SwigClassWrapper const *farg2, size_t const *farg3) { SwigClassWrapper fresult ; Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > *arg1 = 0 ; - size_t arg2 ; + Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > *arg2 = 0 ; + size_t arg3 ; Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > tempnull1 ; + Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > tempnull2 ; Tpetra::CrsMatrix< SC,LO,GO,NO > *result = 0 ; arg1 = farg1->cptr ? static_cast< Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg1->cptr) : &tempnull1; - arg2 = static_cast< size_t >(*farg2); + arg2 = farg2->cptr ? static_cast< Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg2->cptr) : &tempnull2; + arg3 = static_cast< size_t >(*farg3); { // Make sure no unhandled exceptions exist before performing a new action - SWIG_check_unhandled_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::CrsMatrix(Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,size_t)");; + SWIG_check_unhandled_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::CrsMatrix(Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,size_t)");; try { // Attempt the wrapped function call - result = (Tpetra::CrsMatrix< SC,LO,GO,NO > *)new Tpetra::CrsMatrix< SC,LO,GO,NO >((Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &)*arg1,arg2); + result = (Tpetra::CrsMatrix< SC,LO,GO,NO > *)new Tpetra::CrsMatrix< SC,LO,GO,NO >((Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &)*arg1,(Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &)*arg2,arg3); } catch (const std::range_error& e) { // Store a C++ exception - SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::CrsMatrix(Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,size_t)", SWIG_IndexError, e.what(), return SwigClassWrapper_uninitialized()); + SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::CrsMatrix(Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,size_t)", SWIG_IndexError, e.what(), return SwigClassWrapper_uninitialized()); } catch (const std::exception& e) { // Store a C++ exception - SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::CrsMatrix(Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,size_t)", SWIG_RuntimeError, e.what(), return SwigClassWrapper_uninitialized()); + SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::CrsMatrix(Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,size_t)", SWIG_RuntimeError, e.what(), return SwigClassWrapper_uninitialized()); } catch (...) { - SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::CrsMatrix(Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,size_t)", SWIG_UnknownError, "An unknown exception occurred", return SwigClassWrapper_uninitialized()); + SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::CrsMatrix(Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,size_t)", SWIG_UnknownError, "An unknown exception occurred", return SwigClassWrapper_uninitialized()); } } fresult.cptr = result ? new Teuchos::RCP< Tpetra::CrsMatrix >(result SWIG_NO_NULL_DELETER_1) : NULL; @@ -10279,44 +10539,46 @@ SWIGEXPORT SwigClassWrapper _wrap_new_TpetraCrsMatrix__SWIG_2(SwigClassWrapper c } -SWIGEXPORT SwigClassWrapper _wrap_new_TpetraCrsMatrix__SWIG_3(SwigClassWrapper const *farg1, SwigClassWrapper const *farg2, size_t const *farg3, int const *farg4, SwigClassWrapper const *farg5) { +SWIGEXPORT SwigClassWrapper _wrap_new_TpetraCrsMatrix__SWIG_9(SwigClassWrapper const *farg1, SwigClassWrapper const *farg2, SwigArrayWrapper *farg3, int const *farg4, SwigClassWrapper const *farg5) { SwigClassWrapper fresult ; Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > *arg1 = 0 ; Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > *arg2 = 0 ; - size_t arg3 ; + Teuchos::ArrayRCP< std::size_t const > *arg3 = 0 ; Tpetra::ProfileType arg4 ; Teuchos::RCP< Teuchos::ParameterList > *arg5 = 0 ; Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > tempnull1 ; Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > tempnull2 ; + Teuchos::ArrayRCP< unsigned long const > tmparr3 ; Teuchos::RCP< Teuchos::ParameterList > tempnull5 ; Tpetra::CrsMatrix< SC,LO,GO,NO > *result = 0 ; arg1 = farg1->cptr ? static_cast< Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg1->cptr) : &tempnull1; arg2 = farg2->cptr ? static_cast< Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg2->cptr) : &tempnull2; - arg3 = static_cast< size_t >(*farg3); + tmparr3 = Teuchos::ArrayRCP(static_cast(farg3->data), 0, farg3->size, false, Teuchos::RCP_DISABLE_NODE_LOOKUP); + arg3 = &tmparr3; arg4 = static_cast< Tpetra::ProfileType >(*farg4); arg5 = farg5->cptr ? static_cast< Teuchos::RCP< Teuchos::ParameterList > * >(farg5->cptr) : &tempnull5; { // Make sure no unhandled exceptions exist before performing a new action - SWIG_check_unhandled_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::CrsMatrix(Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,size_t,Tpetra::ProfileType,Teuchos::RCP< Teuchos::ParameterList > const &)");; + SWIG_check_unhandled_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::CrsMatrix(Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::ArrayRCP< std::size_t const > const &,Tpetra::ProfileType,Teuchos::RCP< Teuchos::ParameterList > const &)");; try { // Attempt the wrapped function call - result = (Tpetra::CrsMatrix< SC,LO,GO,NO > *)new Tpetra::CrsMatrix< SC,LO,GO,NO >((Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &)*arg1,(Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &)*arg2,arg3,arg4,(Teuchos::RCP< Teuchos::ParameterList > const &)*arg5); + result = (Tpetra::CrsMatrix< SC,LO,GO,NO > *)new Tpetra::CrsMatrix< SC,LO,GO,NO >((Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &)*arg1,(Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &)*arg2,(Teuchos::ArrayRCP< std::size_t const > const &)*arg3,arg4,(Teuchos::RCP< Teuchos::ParameterList > const &)*arg5); } catch (const std::range_error& e) { // Store a C++ exception - SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::CrsMatrix(Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,size_t,Tpetra::ProfileType,Teuchos::RCP< Teuchos::ParameterList > const &)", SWIG_IndexError, e.what(), return SwigClassWrapper_uninitialized()); + SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::CrsMatrix(Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::ArrayRCP< std::size_t const > const &,Tpetra::ProfileType,Teuchos::RCP< Teuchos::ParameterList > const &)", SWIG_IndexError, e.what(), return SwigClassWrapper_uninitialized()); } catch (const std::exception& e) { // Store a C++ exception - SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::CrsMatrix(Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,size_t,Tpetra::ProfileType,Teuchos::RCP< Teuchos::ParameterList > const &)", SWIG_RuntimeError, e.what(), return SwigClassWrapper_uninitialized()); + SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::CrsMatrix(Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::ArrayRCP< std::size_t const > const &,Tpetra::ProfileType,Teuchos::RCP< Teuchos::ParameterList > const &)", SWIG_RuntimeError, e.what(), return SwigClassWrapper_uninitialized()); } catch (...) { - SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::CrsMatrix(Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,size_t,Tpetra::ProfileType,Teuchos::RCP< Teuchos::ParameterList > const &)", SWIG_UnknownError, "An unknown exception occurred", return SwigClassWrapper_uninitialized()); + SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::CrsMatrix(Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::ArrayRCP< std::size_t const > const &,Tpetra::ProfileType,Teuchos::RCP< Teuchos::ParameterList > const &)", SWIG_UnknownError, "An unknown exception occurred", return SwigClassWrapper_uninitialized()); } } fresult.cptr = result ? new Teuchos::RCP< Tpetra::CrsMatrix >(result SWIG_NO_NULL_DELETER_1) : NULL; @@ -10325,41 +10587,43 @@ SWIGEXPORT SwigClassWrapper _wrap_new_TpetraCrsMatrix__SWIG_3(SwigClassWrapper c } -SWIGEXPORT SwigClassWrapper _wrap_new_TpetraCrsMatrix__SWIG_4(SwigClassWrapper const *farg1, SwigClassWrapper const *farg2, size_t const *farg3, int const *farg4) { +SWIGEXPORT SwigClassWrapper _wrap_new_TpetraCrsMatrix__SWIG_10(SwigClassWrapper const *farg1, SwigClassWrapper const *farg2, SwigArrayWrapper *farg3, int const *farg4) { SwigClassWrapper fresult ; Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > *arg1 = 0 ; Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > *arg2 = 0 ; - size_t arg3 ; + Teuchos::ArrayRCP< std::size_t const > *arg3 = 0 ; Tpetra::ProfileType arg4 ; Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > tempnull1 ; Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > tempnull2 ; + Teuchos::ArrayRCP< unsigned long const > tmparr3 ; Tpetra::CrsMatrix< SC,LO,GO,NO > *result = 0 ; arg1 = farg1->cptr ? static_cast< Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg1->cptr) : &tempnull1; arg2 = farg2->cptr ? static_cast< Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg2->cptr) : &tempnull2; - arg3 = static_cast< size_t >(*farg3); + tmparr3 = Teuchos::ArrayRCP(static_cast(farg3->data), 0, farg3->size, false, Teuchos::RCP_DISABLE_NODE_LOOKUP); + arg3 = &tmparr3; arg4 = static_cast< Tpetra::ProfileType >(*farg4); { // Make sure no unhandled exceptions exist before performing a new action - SWIG_check_unhandled_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::CrsMatrix(Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,size_t,Tpetra::ProfileType)");; + SWIG_check_unhandled_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::CrsMatrix(Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::ArrayRCP< std::size_t const > const &,Tpetra::ProfileType)");; try { // Attempt the wrapped function call - result = (Tpetra::CrsMatrix< SC,LO,GO,NO > *)new Tpetra::CrsMatrix< SC,LO,GO,NO >((Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &)*arg1,(Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &)*arg2,arg3,arg4); + result = (Tpetra::CrsMatrix< SC,LO,GO,NO > *)new Tpetra::CrsMatrix< SC,LO,GO,NO >((Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &)*arg1,(Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &)*arg2,(Teuchos::ArrayRCP< std::size_t const > const &)*arg3,arg4); } catch (const std::range_error& e) { // Store a C++ exception - SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::CrsMatrix(Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,size_t,Tpetra::ProfileType)", SWIG_IndexError, e.what(), return SwigClassWrapper_uninitialized()); + SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::CrsMatrix(Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::ArrayRCP< std::size_t const > const &,Tpetra::ProfileType)", SWIG_IndexError, e.what(), return SwigClassWrapper_uninitialized()); } catch (const std::exception& e) { // Store a C++ exception - SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::CrsMatrix(Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,size_t,Tpetra::ProfileType)", SWIG_RuntimeError, e.what(), return SwigClassWrapper_uninitialized()); + SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::CrsMatrix(Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::ArrayRCP< std::size_t const > const &,Tpetra::ProfileType)", SWIG_RuntimeError, e.what(), return SwigClassWrapper_uninitialized()); } catch (...) { - SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::CrsMatrix(Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,size_t,Tpetra::ProfileType)", SWIG_UnknownError, "An unknown exception occurred", return SwigClassWrapper_uninitialized()); + SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::CrsMatrix(Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::ArrayRCP< std::size_t const > const &,Tpetra::ProfileType)", SWIG_UnknownError, "An unknown exception occurred", return SwigClassWrapper_uninitialized()); } } fresult.cptr = result ? new Teuchos::RCP< Tpetra::CrsMatrix >(result SWIG_NO_NULL_DELETER_1) : NULL; @@ -10368,39 +10632,41 @@ SWIGEXPORT SwigClassWrapper _wrap_new_TpetraCrsMatrix__SWIG_4(SwigClassWrapper c } -SWIGEXPORT SwigClassWrapper _wrap_new_TpetraCrsMatrix__SWIG_5(SwigClassWrapper const *farg1, SwigClassWrapper const *farg2, size_t const *farg3) { +SWIGEXPORT SwigClassWrapper _wrap_new_TpetraCrsMatrix__SWIG_11(SwigClassWrapper const *farg1, SwigClassWrapper const *farg2, SwigArrayWrapper *farg3) { SwigClassWrapper fresult ; Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > *arg1 = 0 ; Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > *arg2 = 0 ; - size_t arg3 ; + Teuchos::ArrayRCP< std::size_t const > *arg3 = 0 ; Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > tempnull1 ; Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > tempnull2 ; + Teuchos::ArrayRCP< unsigned long const > tmparr3 ; Tpetra::CrsMatrix< SC,LO,GO,NO > *result = 0 ; arg1 = farg1->cptr ? static_cast< Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg1->cptr) : &tempnull1; arg2 = farg2->cptr ? static_cast< Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg2->cptr) : &tempnull2; - arg3 = static_cast< size_t >(*farg3); + tmparr3 = Teuchos::ArrayRCP(static_cast(farg3->data), 0, farg3->size, false, Teuchos::RCP_DISABLE_NODE_LOOKUP); + arg3 = &tmparr3; { // Make sure no unhandled exceptions exist before performing a new action - SWIG_check_unhandled_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::CrsMatrix(Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,size_t)");; + SWIG_check_unhandled_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::CrsMatrix(Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::ArrayRCP< std::size_t const > const &)");; try { // Attempt the wrapped function call - result = (Tpetra::CrsMatrix< SC,LO,GO,NO > *)new Tpetra::CrsMatrix< SC,LO,GO,NO >((Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &)*arg1,(Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &)*arg2,arg3); + result = (Tpetra::CrsMatrix< SC,LO,GO,NO > *)new Tpetra::CrsMatrix< SC,LO,GO,NO >((Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &)*arg1,(Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &)*arg2,(Teuchos::ArrayRCP< std::size_t const > const &)*arg3); } catch (const std::range_error& e) { // Store a C++ exception - SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::CrsMatrix(Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,size_t)", SWIG_IndexError, e.what(), return SwigClassWrapper_uninitialized()); + SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::CrsMatrix(Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::ArrayRCP< std::size_t const > const &)", SWIG_IndexError, e.what(), return SwigClassWrapper_uninitialized()); } catch (const std::exception& e) { // Store a C++ exception - SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::CrsMatrix(Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,size_t)", SWIG_RuntimeError, e.what(), return SwigClassWrapper_uninitialized()); + SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::CrsMatrix(Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::ArrayRCP< std::size_t const > const &)", SWIG_RuntimeError, e.what(), return SwigClassWrapper_uninitialized()); } catch (...) { - SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::CrsMatrix(Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,size_t)", SWIG_UnknownError, "An unknown exception occurred", return SwigClassWrapper_uninitialized()); + SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::CrsMatrix(Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::ArrayRCP< std::size_t const > const &)", SWIG_UnknownError, "An unknown exception occurred", return SwigClassWrapper_uninitialized()); } } fresult.cptr = result ? new Teuchos::RCP< Tpetra::CrsMatrix >(result SWIG_NO_NULL_DELETER_1) : NULL; @@ -10409,7 +10675,7 @@ SWIGEXPORT SwigClassWrapper _wrap_new_TpetraCrsMatrix__SWIG_5(SwigClassWrapper c } -SWIGEXPORT SwigClassWrapper _wrap_new_TpetraCrsMatrix__SWIG_6(SwigClassWrapper const *farg1, SwigClassWrapper const *farg2) { +SWIGEXPORT SwigClassWrapper _wrap_new_TpetraCrsMatrix__SWIG_12(SwigClassWrapper const *farg1, SwigClassWrapper const *farg2) { SwigClassWrapper fresult ; Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::crs_graph_type const > *arg1 = 0 ; Teuchos::RCP< Teuchos::ParameterList > *arg2 = 0 ; @@ -10448,7 +10714,7 @@ SWIGEXPORT SwigClassWrapper _wrap_new_TpetraCrsMatrix__SWIG_6(SwigClassWrapper c } -SWIGEXPORT SwigClassWrapper _wrap_new_TpetraCrsMatrix__SWIG_7(SwigClassWrapper const *farg1) { +SWIGEXPORT SwigClassWrapper _wrap_new_TpetraCrsMatrix__SWIG_13(SwigClassWrapper const *farg1) { SwigClassWrapper fresult ; Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::crs_graph_type const > *arg1 = 0 ; Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::crs_graph_type const > tempnull1 ; @@ -10484,7 +10750,7 @@ SWIGEXPORT SwigClassWrapper _wrap_new_TpetraCrsMatrix__SWIG_7(SwigClassWrapper c } -SWIGEXPORT SwigClassWrapper _wrap_new_TpetraCrsMatrix__SWIG_8(SwigClassWrapper const *farg1, SwigClassWrapper const *farg2, SwigClassWrapper const *farg3) { +SWIGEXPORT SwigClassWrapper _wrap_new_TpetraCrsMatrix__SWIG_14(SwigClassWrapper const *farg1, SwigClassWrapper const *farg2, SwigClassWrapper const *farg3) { SwigClassWrapper fresult ; Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::crs_graph_type const > *arg1 = 0 ; Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::local_matrix_type::values_type *arg2 = 0 ; @@ -10526,7 +10792,7 @@ SWIGEXPORT SwigClassWrapper _wrap_new_TpetraCrsMatrix__SWIG_8(SwigClassWrapper c } -SWIGEXPORT SwigClassWrapper _wrap_new_TpetraCrsMatrix__SWIG_9(SwigClassWrapper const *farg1, SwigClassWrapper const *farg2) { +SWIGEXPORT SwigClassWrapper _wrap_new_TpetraCrsMatrix__SWIG_15(SwigClassWrapper const *farg1, SwigClassWrapper const *farg2) { SwigClassWrapper fresult ; Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::crs_graph_type const > *arg1 = 0 ; Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::local_matrix_type::values_type *arg2 = 0 ; @@ -10565,17 +10831,146 @@ SWIGEXPORT SwigClassWrapper _wrap_new_TpetraCrsMatrix__SWIG_9(SwigClassWrapper c } -SWIGEXPORT void _wrap_delete_TpetraCrsMatrix(SwigClassWrapper const *farg1) { - Tpetra::CrsMatrix< SC,LO,GO,NO > *arg1 = (Tpetra::CrsMatrix< SC,LO,GO,NO > *) 0 ; - Teuchos::RCP< Tpetra::CrsMatrix< SC,LO,GO,NO > > *smartarg1 ; - - smartarg1 = static_cast< Teuchos::RCP< Tpetra::CrsMatrix >* >(farg1->cptr); - arg1 = smartarg1 ? const_cast< Tpetra::CrsMatrix* >(smartarg1->get()) : NULL; - { - // Make sure no unhandled exceptions exist before performing a new action - SWIG_check_unhandled_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::~CrsMatrix()");; - try - { +SWIGEXPORT SwigClassWrapper _wrap_new_TpetraCrsMatrix__SWIG_16(SwigClassWrapper const *farg1, SwigClassWrapper const *farg2, SwigArrayWrapper *farg3, SwigArrayWrapper *farg4, SwigArrayWrapper *farg5, SwigClassWrapper const *farg6) { + SwigClassWrapper fresult ; + Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > *arg1 = 0 ; + Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > *arg2 = 0 ; + Teuchos::ArrayRCP< std::size_t > *arg3 = 0 ; + Teuchos::ArrayRCP< int > *arg4 = 0 ; + Teuchos::ArrayRCP< double > *arg5 = 0 ; + Teuchos::RCP< Teuchos::ParameterList > *arg6 = 0 ; + Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > tempnull1 ; + Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > tempnull2 ; + Teuchos::ArrayRCP< std::size_t >::value_type *tmpbegin3 ; + Teuchos::ArrayRCP< std::remove_const< Teuchos::ArrayRCP< std::size_t >::value_type >::type > tmparr3 ; + Teuchos::ArrayRCP< std::size_t > tmprcp3 ; + Teuchos::ArrayRCP< int >::value_type *tmpbegin4 ; + Teuchos::ArrayRCP< std::remove_const< Teuchos::ArrayRCP< int >::value_type >::type > tmparr4 ; + Teuchos::ArrayRCP< int > tmprcp4 ; + Teuchos::ArrayRCP< double > tmparr5 ; + Teuchos::RCP< Teuchos::ParameterList > tempnull6 ; + Tpetra::CrsMatrix< SC,LO,GO,NO > *result = 0 ; + + arg1 = farg1->cptr ? static_cast< Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg1->cptr) : &tempnull1; + arg2 = farg2->cptr ? static_cast< Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg2->cptr) : &tempnull2; + tmpbegin3 = static_cast::value_type*>(farg3->data); + tmparr3.resize(farg3->size); + for (int i = 0; i < tmparr3.size(); i++) + tmparr3[i] = tmpbegin3[i] - 1; + tmprcp3 = tmparr3; + arg3 = &tmprcp3; + tmpbegin4 = static_cast::value_type*>(farg4->data); + tmparr4.resize(farg4->size); + for (int i = 0; i < tmparr4.size(); i++) + tmparr4[i] = tmpbegin4[i] - 1; + tmprcp4 = tmparr4; + arg4 = &tmprcp4; + tmparr5 = Teuchos::ArrayRCP(static_cast(farg5->data), 0, farg5->size, false, Teuchos::RCP_DISABLE_NODE_LOOKUP); + arg5 = &tmparr5; + arg6 = farg6->cptr ? static_cast< Teuchos::RCP< Teuchos::ParameterList > * >(farg6->cptr) : &tempnull6; + { + // Make sure no unhandled exceptions exist before performing a new action + SWIG_check_unhandled_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::CrsMatrix(Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::ArrayRCP< std::size_t > const &,Teuchos::ArrayRCP< int > const &,Teuchos::ArrayRCP< double > const &,Teuchos::RCP< Teuchos::ParameterList > const &)");; + try + { + // Attempt the wrapped function call + result = (Tpetra::CrsMatrix< SC,LO,GO,NO > *)new Tpetra::CrsMatrix< SC,LO,GO,NO >((Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &)*arg1,(Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &)*arg2,(Teuchos::ArrayRCP< std::size_t > const &)*arg3,(Teuchos::ArrayRCP< int > const &)*arg4,(Teuchos::ArrayRCP< double > const &)*arg5,(Teuchos::RCP< Teuchos::ParameterList > const &)*arg6); + } + catch (const std::range_error& e) + { + // Store a C++ exception + SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::CrsMatrix(Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::ArrayRCP< std::size_t > const &,Teuchos::ArrayRCP< int > const &,Teuchos::ArrayRCP< double > const &,Teuchos::RCP< Teuchos::ParameterList > const &)", SWIG_IndexError, e.what(), return SwigClassWrapper_uninitialized()); + } + catch (const std::exception& e) + { + // Store a C++ exception + SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::CrsMatrix(Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::ArrayRCP< std::size_t > const &,Teuchos::ArrayRCP< int > const &,Teuchos::ArrayRCP< double > const &,Teuchos::RCP< Teuchos::ParameterList > const &)", SWIG_RuntimeError, e.what(), return SwigClassWrapper_uninitialized()); + } + catch (...) + { + SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::CrsMatrix(Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::ArrayRCP< std::size_t > const &,Teuchos::ArrayRCP< int > const &,Teuchos::ArrayRCP< double > const &,Teuchos::RCP< Teuchos::ParameterList > const &)", SWIG_UnknownError, "An unknown exception occurred", return SwigClassWrapper_uninitialized()); + } + } + fresult.cptr = result ? new Teuchos::RCP< Tpetra::CrsMatrix >(result SWIG_NO_NULL_DELETER_1) : NULL; + fresult.mem = SWIG_MOVE; + return fresult; +} + + +SWIGEXPORT SwigClassWrapper _wrap_new_TpetraCrsMatrix__SWIG_17(SwigClassWrapper const *farg1, SwigClassWrapper const *farg2, SwigArrayWrapper *farg3, SwigArrayWrapper *farg4, SwigArrayWrapper *farg5) { + SwigClassWrapper fresult ; + Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > *arg1 = 0 ; + Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > *arg2 = 0 ; + Teuchos::ArrayRCP< std::size_t > *arg3 = 0 ; + Teuchos::ArrayRCP< int > *arg4 = 0 ; + Teuchos::ArrayRCP< double > *arg5 = 0 ; + Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > tempnull1 ; + Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > tempnull2 ; + Teuchos::ArrayRCP< std::size_t >::value_type *tmpbegin3 ; + Teuchos::ArrayRCP< std::remove_const< Teuchos::ArrayRCP< std::size_t >::value_type >::type > tmparr3 ; + Teuchos::ArrayRCP< std::size_t > tmprcp3 ; + Teuchos::ArrayRCP< int >::value_type *tmpbegin4 ; + Teuchos::ArrayRCP< std::remove_const< Teuchos::ArrayRCP< int >::value_type >::type > tmparr4 ; + Teuchos::ArrayRCP< int > tmprcp4 ; + Teuchos::ArrayRCP< double > tmparr5 ; + Tpetra::CrsMatrix< SC,LO,GO,NO > *result = 0 ; + + arg1 = farg1->cptr ? static_cast< Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg1->cptr) : &tempnull1; + arg2 = farg2->cptr ? static_cast< Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg2->cptr) : &tempnull2; + tmpbegin3 = static_cast::value_type*>(farg3->data); + tmparr3.resize(farg3->size); + for (int i = 0; i < tmparr3.size(); i++) + tmparr3[i] = tmpbegin3[i] - 1; + tmprcp3 = tmparr3; + arg3 = &tmprcp3; + tmpbegin4 = static_cast::value_type*>(farg4->data); + tmparr4.resize(farg4->size); + for (int i = 0; i < tmparr4.size(); i++) + tmparr4[i] = tmpbegin4[i] - 1; + tmprcp4 = tmparr4; + arg4 = &tmprcp4; + tmparr5 = Teuchos::ArrayRCP(static_cast(farg5->data), 0, farg5->size, false, Teuchos::RCP_DISABLE_NODE_LOOKUP); + arg5 = &tmparr5; + { + // Make sure no unhandled exceptions exist before performing a new action + SWIG_check_unhandled_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::CrsMatrix(Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::ArrayRCP< std::size_t > const &,Teuchos::ArrayRCP< int > const &,Teuchos::ArrayRCP< double > const &)");; + try + { + // Attempt the wrapped function call + result = (Tpetra::CrsMatrix< SC,LO,GO,NO > *)new Tpetra::CrsMatrix< SC,LO,GO,NO >((Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &)*arg1,(Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &)*arg2,(Teuchos::ArrayRCP< std::size_t > const &)*arg3,(Teuchos::ArrayRCP< int > const &)*arg4,(Teuchos::ArrayRCP< double > const &)*arg5); + } + catch (const std::range_error& e) + { + // Store a C++ exception + SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::CrsMatrix(Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::ArrayRCP< std::size_t > const &,Teuchos::ArrayRCP< int > const &,Teuchos::ArrayRCP< double > const &)", SWIG_IndexError, e.what(), return SwigClassWrapper_uninitialized()); + } + catch (const std::exception& e) + { + // Store a C++ exception + SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::CrsMatrix(Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::ArrayRCP< std::size_t > const &,Teuchos::ArrayRCP< int > const &,Teuchos::ArrayRCP< double > const &)", SWIG_RuntimeError, e.what(), return SwigClassWrapper_uninitialized()); + } + catch (...) + { + SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::CrsMatrix(Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::ArrayRCP< std::size_t > const &,Teuchos::ArrayRCP< int > const &,Teuchos::ArrayRCP< double > const &)", SWIG_UnknownError, "An unknown exception occurred", return SwigClassWrapper_uninitialized()); + } + } + fresult.cptr = result ? new Teuchos::RCP< Tpetra::CrsMatrix >(result SWIG_NO_NULL_DELETER_1) : NULL; + fresult.mem = SWIG_MOVE; + return fresult; +} + + +SWIGEXPORT void _wrap_delete_TpetraCrsMatrix(SwigClassWrapper const *farg1) { + Tpetra::CrsMatrix< SC,LO,GO,NO > *arg1 = (Tpetra::CrsMatrix< SC,LO,GO,NO > *) 0 ; + Teuchos::RCP< Tpetra::CrsMatrix< SC,LO,GO,NO > > *smartarg1 ; + + smartarg1 = static_cast< Teuchos::RCP< Tpetra::CrsMatrix >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::CrsMatrix* >(smartarg1->get()) : NULL; + { + // Make sure no unhandled exceptions exist before performing a new action + SWIG_check_unhandled_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::~CrsMatrix()");; + try + { // Attempt the wrapped function call (void)arg1; delete smartarg1; } @@ -11012,6 +11407,63 @@ SWIGEXPORT void _wrap_TpetraCrsMatrix_scale(SwigClassWrapper const *farg1, doubl } +SWIGEXPORT void _wrap_TpetraCrsMatrix_setAllValues(SwigClassWrapper const *farg1, SwigArrayWrapper *farg2, SwigArrayWrapper *farg3, SwigArrayWrapper *farg4) { + Tpetra::CrsMatrix< SC,LO,GO,NO > *arg1 = (Tpetra::CrsMatrix< SC,LO,GO,NO > *) 0 ; + Teuchos::ArrayRCP< std::size_t > *arg2 = 0 ; + Teuchos::ArrayRCP< int > *arg3 = 0 ; + Teuchos::ArrayRCP< double > *arg4 = 0 ; + Teuchos::RCP< Tpetra::CrsMatrix< SC,LO,GO,NO > > *smartarg1 ; + Teuchos::ArrayRCP< std::size_t >::value_type *tmpbegin2 ; + Teuchos::ArrayRCP< std::remove_const< Teuchos::ArrayRCP< std::size_t >::value_type >::type > tmparr2 ; + Teuchos::ArrayRCP< std::size_t > tmprcp2 ; + Teuchos::ArrayRCP< int >::value_type *tmpbegin3 ; + Teuchos::ArrayRCP< std::remove_const< Teuchos::ArrayRCP< int >::value_type >::type > tmparr3 ; + Teuchos::ArrayRCP< int > tmprcp3 ; + Teuchos::ArrayRCP< double > tmparr4 ; + + smartarg1 = static_cast< Teuchos::RCP< Tpetra::CrsMatrix >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::CrsMatrix* >(smartarg1->get()) : NULL; + tmpbegin2 = static_cast::value_type*>(farg2->data); + tmparr2.resize(farg2->size); + for (int i = 0; i < tmparr2.size(); i++) + tmparr2[i] = tmpbegin2[i] - 1; + tmprcp2 = tmparr2; + arg2 = &tmprcp2; + tmpbegin3 = static_cast::value_type*>(farg3->data); + tmparr3.resize(farg3->size); + for (int i = 0; i < tmparr3.size(); i++) + tmparr3[i] = tmpbegin3[i] - 1; + tmprcp3 = tmparr3; + arg3 = &tmprcp3; + tmparr4 = Teuchos::ArrayRCP(static_cast(farg4->data), 0, farg4->size, false, Teuchos::RCP_DISABLE_NODE_LOOKUP); + arg4 = &tmparr4; + { + // Make sure no unhandled exceptions exist before performing a new action + SWIG_check_unhandled_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::setAllValues(Teuchos::ArrayRCP< std::size_t > const &,Teuchos::ArrayRCP< int > const &,Teuchos::ArrayRCP< double > const &)");; + try + { + // Attempt the wrapped function call + (arg1)->setAllValues((Teuchos::ArrayRCP< std::size_t > const &)*arg2,(Teuchos::ArrayRCP< int > const &)*arg3,(Teuchos::ArrayRCP< double > const &)*arg4); + } + catch (const std::range_error& e) + { + // Store a C++ exception + SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::setAllValues(Teuchos::ArrayRCP< std::size_t > const &,Teuchos::ArrayRCP< int > const &,Teuchos::ArrayRCP< double > const &)", SWIG_IndexError, e.what(), return ); + } + catch (const std::exception& e) + { + // Store a C++ exception + SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::setAllValues(Teuchos::ArrayRCP< std::size_t > const &,Teuchos::ArrayRCP< int > const &,Teuchos::ArrayRCP< double > const &)", SWIG_RuntimeError, e.what(), return ); + } + catch (...) + { + SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::setAllValues(Teuchos::ArrayRCP< std::size_t > const &,Teuchos::ArrayRCP< int > const &,Teuchos::ArrayRCP< double > const &)", SWIG_UnknownError, "An unknown exception occurred", return ); + } + } + +} + + SWIGEXPORT void _wrap_TpetraCrsMatrix_globalAssemble(SwigClassWrapper const *farg1) { Tpetra::CrsMatrix< SC,LO,GO,NO > *arg1 = (Tpetra::CrsMatrix< SC,LO,GO,NO > *) 0 ; Teuchos::RCP< Tpetra::CrsMatrix< SC,LO,GO,NO > > *smartarg1 ; @@ -12688,6 +13140,42 @@ SWIGEXPORT void _wrap_TpetraCrsMatrix_getGlobalRowView(SwigClassWrapper const *f } +SWIGEXPORT void _wrap_TpetraCrsMatrix_getLocalDiagOffsets(SwigClassWrapper const *farg1, SwigClassWrapper const *farg2) { + Tpetra::CrsMatrix< SC,LO,GO,NO > *arg1 = (Tpetra::CrsMatrix< SC,LO,GO,NO > *) 0 ; + Teuchos::ArrayRCP< std::size_t > *arg2 = 0 ; + Teuchos::RCP< Tpetra::CrsMatrix< SC,LO,GO,NO > const > *smartarg1 ; + + smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::CrsMatrix* >(smartarg1->get()) : NULL; + SWIG_check_mutable_nonnull(*farg2, "Teuchos::ArrayRCP< std::size_t > &", "SWIGTYPE_Teuchos__ArrayRCPT_unsigned_long_t", "Tpetra::CrsMatrix< SC,LO,GO,NO >::getLocalDiagOffsets(Teuchos::ArrayRCP< std::size_t > &) const", return ); + arg2 = static_cast< Teuchos::ArrayRCP< std::size_t > * >(farg2->cptr); + { + // Make sure no unhandled exceptions exist before performing a new action + SWIG_check_unhandled_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::getLocalDiagOffsets(Teuchos::ArrayRCP< std::size_t > &) const");; + try + { + // Attempt the wrapped function call + ((Tpetra::CrsMatrix< SC,LO,GO,NO > const *)arg1)->getLocalDiagOffsets(*arg2); + } + catch (const std::range_error& e) + { + // Store a C++ exception + SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::getLocalDiagOffsets(Teuchos::ArrayRCP< std::size_t > &) const", SWIG_IndexError, e.what(), return ); + } + catch (const std::exception& e) + { + // Store a C++ exception + SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::getLocalDiagOffsets(Teuchos::ArrayRCP< std::size_t > &) const", SWIG_RuntimeError, e.what(), return ); + } + catch (...) + { + SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::getLocalDiagOffsets(Teuchos::ArrayRCP< std::size_t > &) const", SWIG_UnknownError, "An unknown exception occurred", return ); + } + } + +} + + SWIGEXPORT void _wrap_TpetraCrsMatrix_apply__SWIG_0(SwigClassWrapper const *farg1, SwigClassWrapper const *farg2, SwigClassWrapper const *farg3, int const *farg4, double const *farg5, double const *farg6) { Tpetra::CrsMatrix< SC,LO,GO,NO > *arg1 = (Tpetra::CrsMatrix< SC,LO,GO,NO > *) 0 ; Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > *arg2 = 0 ; @@ -13596,389 +14084,6 @@ SWIGEXPORT int _wrap_TpetraCrsMatrix_haveGlobalConstants(SwigClassWrapper const } -SWIGEXPORT SwigClassWrapper _wrap_new_TpetraCrsMatrix__SWIG_10(SwigClassWrapper const *farg1, SwigArrayWrapper *farg2, int const *farg3, SwigClassWrapper const *farg4) { - SwigClassWrapper fresult ; - Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > *arg1 = 0 ; - Teuchos::ArrayView< std::size_t const > arg2 ; - Tpetra::ProfileType arg3 ; - Teuchos::RCP< Teuchos::ParameterList > *arg4 = 0 ; - Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > tempnull1 ; - Teuchos::RCP< Teuchos::ParameterList > tempnull4 ; - Tpetra::CrsMatrix< SC,LO,GO,NO > *result = 0 ; - - arg1 = farg1->cptr ? static_cast< Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg1->cptr) : &tempnull1; - arg2 = Teuchos::ArrayView(static_cast(farg2->data), farg2->size); - arg3 = static_cast< Tpetra::ProfileType >(*farg3); - arg4 = farg4->cptr ? static_cast< Teuchos::RCP< Teuchos::ParameterList > * >(farg4->cptr) : &tempnull4; - { - // Make sure no unhandled exceptions exist before performing a new action - SWIG_check_unhandled_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::CrsMatrix(Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::ArrayView< std::size_t const >,Tpetra::ProfileType,Teuchos::RCP< Teuchos::ParameterList > const &)");; - try - { - // Attempt the wrapped function call - result = (Tpetra::CrsMatrix< SC,LO,GO,NO > *)new_Tpetra_CrsMatrix_Sl_SC_Sc_LO_Sc_GO_Sc_NO_Sg___SWIG_10((Teuchos::RCP< Tpetra::Map< int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const > const &)*arg1,arg2,arg3,(Teuchos::RCP< Teuchos::ParameterList > const &)*arg4); - } - catch (const std::range_error& e) - { - // Store a C++ exception - SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::CrsMatrix(Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::ArrayView< std::size_t const >,Tpetra::ProfileType,Teuchos::RCP< Teuchos::ParameterList > const &)", SWIG_IndexError, e.what(), return SwigClassWrapper_uninitialized()); - } - catch (const std::exception& e) - { - // Store a C++ exception - SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::CrsMatrix(Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::ArrayView< std::size_t const >,Tpetra::ProfileType,Teuchos::RCP< Teuchos::ParameterList > const &)", SWIG_RuntimeError, e.what(), return SwigClassWrapper_uninitialized()); - } - catch (...) - { - SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::CrsMatrix(Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::ArrayView< std::size_t const >,Tpetra::ProfileType,Teuchos::RCP< Teuchos::ParameterList > const &)", SWIG_UnknownError, "An unknown exception occurred", return SwigClassWrapper_uninitialized()); - } - } - fresult.cptr = result ? new Teuchos::RCP< Tpetra::CrsMatrix >(result SWIG_NO_NULL_DELETER_1) : NULL; - fresult.mem = SWIG_MOVE; - return fresult; -} - - -SWIGEXPORT SwigClassWrapper _wrap_new_TpetraCrsMatrix__SWIG_11(SwigClassWrapper const *farg1, SwigArrayWrapper *farg2, int const *farg3) { - SwigClassWrapper fresult ; - Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > *arg1 = 0 ; - Teuchos::ArrayView< std::size_t const > arg2 ; - Tpetra::ProfileType arg3 ; - Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > tempnull1 ; - Tpetra::CrsMatrix< SC,LO,GO,NO > *result = 0 ; - - arg1 = farg1->cptr ? static_cast< Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg1->cptr) : &tempnull1; - arg2 = Teuchos::ArrayView(static_cast(farg2->data), farg2->size); - arg3 = static_cast< Tpetra::ProfileType >(*farg3); - { - // Make sure no unhandled exceptions exist before performing a new action - SWIG_check_unhandled_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::CrsMatrix(Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::ArrayView< std::size_t const >,Tpetra::ProfileType)");; - try - { - // Attempt the wrapped function call - result = (Tpetra::CrsMatrix< SC,LO,GO,NO > *)new_Tpetra_CrsMatrix_Sl_SC_Sc_LO_Sc_GO_Sc_NO_Sg___SWIG_10((Teuchos::RCP< Tpetra::Map< int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const > const &)*arg1,arg2,arg3); - } - catch (const std::range_error& e) - { - // Store a C++ exception - SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::CrsMatrix(Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::ArrayView< std::size_t const >,Tpetra::ProfileType)", SWIG_IndexError, e.what(), return SwigClassWrapper_uninitialized()); - } - catch (const std::exception& e) - { - // Store a C++ exception - SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::CrsMatrix(Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::ArrayView< std::size_t const >,Tpetra::ProfileType)", SWIG_RuntimeError, e.what(), return SwigClassWrapper_uninitialized()); - } - catch (...) - { - SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::CrsMatrix(Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::ArrayView< std::size_t const >,Tpetra::ProfileType)", SWIG_UnknownError, "An unknown exception occurred", return SwigClassWrapper_uninitialized()); - } - } - fresult.cptr = result ? new Teuchos::RCP< Tpetra::CrsMatrix >(result SWIG_NO_NULL_DELETER_1) : NULL; - fresult.mem = SWIG_MOVE; - return fresult; -} - - -SWIGEXPORT SwigClassWrapper _wrap_new_TpetraCrsMatrix__SWIG_12(SwigClassWrapper const *farg1, SwigArrayWrapper *farg2) { - SwigClassWrapper fresult ; - Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > *arg1 = 0 ; - Teuchos::ArrayView< std::size_t const > arg2 ; - Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > tempnull1 ; - Tpetra::CrsMatrix< SC,LO,GO,NO > *result = 0 ; - - arg1 = farg1->cptr ? static_cast< Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg1->cptr) : &tempnull1; - arg2 = Teuchos::ArrayView(static_cast(farg2->data), farg2->size); - { - // Make sure no unhandled exceptions exist before performing a new action - SWIG_check_unhandled_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::CrsMatrix(Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::ArrayView< std::size_t const >)");; - try - { - // Attempt the wrapped function call - result = (Tpetra::CrsMatrix< SC,LO,GO,NO > *)new_Tpetra_CrsMatrix_Sl_SC_Sc_LO_Sc_GO_Sc_NO_Sg___SWIG_10((Teuchos::RCP< Tpetra::Map< int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const > const &)*arg1,arg2); - } - catch (const std::range_error& e) - { - // Store a C++ exception - SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::CrsMatrix(Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::ArrayView< std::size_t const >)", SWIG_IndexError, e.what(), return SwigClassWrapper_uninitialized()); - } - catch (const std::exception& e) - { - // Store a C++ exception - SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::CrsMatrix(Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::ArrayView< std::size_t const >)", SWIG_RuntimeError, e.what(), return SwigClassWrapper_uninitialized()); - } - catch (...) - { - SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::CrsMatrix(Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::ArrayView< std::size_t const >)", SWIG_UnknownError, "An unknown exception occurred", return SwigClassWrapper_uninitialized()); - } - } - fresult.cptr = result ? new Teuchos::RCP< Tpetra::CrsMatrix >(result SWIG_NO_NULL_DELETER_1) : NULL; - fresult.mem = SWIG_MOVE; - return fresult; -} - - -SWIGEXPORT SwigClassWrapper _wrap_new_TpetraCrsMatrix__SWIG_13(SwigClassWrapper const *farg1, SwigClassWrapper const *farg2, SwigArrayWrapper *farg3, int const *farg4, SwigClassWrapper const *farg5) { - SwigClassWrapper fresult ; - Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > *arg1 = 0 ; - Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > *arg2 = 0 ; - Teuchos::ArrayView< std::size_t const > arg3 ; - Tpetra::ProfileType arg4 ; - Teuchos::RCP< Teuchos::ParameterList > *arg5 = 0 ; - Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > tempnull1 ; - Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > tempnull2 ; - Teuchos::RCP< Teuchos::ParameterList > tempnull5 ; - Tpetra::CrsMatrix< SC,LO,GO,NO > *result = 0 ; - - arg1 = farg1->cptr ? static_cast< Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg1->cptr) : &tempnull1; - arg2 = farg2->cptr ? static_cast< Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg2->cptr) : &tempnull2; - arg3 = Teuchos::ArrayView(static_cast(farg3->data), farg3->size); - arg4 = static_cast< Tpetra::ProfileType >(*farg4); - arg5 = farg5->cptr ? static_cast< Teuchos::RCP< Teuchos::ParameterList > * >(farg5->cptr) : &tempnull5; - { - // Make sure no unhandled exceptions exist before performing a new action - SWIG_check_unhandled_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::CrsMatrix(Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::ArrayView< std::size_t const >,Tpetra::ProfileType,Teuchos::RCP< Teuchos::ParameterList > const &)");; - try - { - // Attempt the wrapped function call - result = (Tpetra::CrsMatrix< SC,LO,GO,NO > *)new_Tpetra_CrsMatrix_Sl_SC_Sc_LO_Sc_GO_Sc_NO_Sg___SWIG_13((Teuchos::RCP< Tpetra::Map< int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const > const &)*arg1,(Teuchos::RCP< Tpetra::Map< int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const > const &)*arg2,arg3,arg4,(Teuchos::RCP< Teuchos::ParameterList > const &)*arg5); - } - catch (const std::range_error& e) - { - // Store a C++ exception - SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::CrsMatrix(Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::ArrayView< std::size_t const >,Tpetra::ProfileType,Teuchos::RCP< Teuchos::ParameterList > const &)", SWIG_IndexError, e.what(), return SwigClassWrapper_uninitialized()); - } - catch (const std::exception& e) - { - // Store a C++ exception - SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::CrsMatrix(Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::ArrayView< std::size_t const >,Tpetra::ProfileType,Teuchos::RCP< Teuchos::ParameterList > const &)", SWIG_RuntimeError, e.what(), return SwigClassWrapper_uninitialized()); - } - catch (...) - { - SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::CrsMatrix(Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::ArrayView< std::size_t const >,Tpetra::ProfileType,Teuchos::RCP< Teuchos::ParameterList > const &)", SWIG_UnknownError, "An unknown exception occurred", return SwigClassWrapper_uninitialized()); - } - } - fresult.cptr = result ? new Teuchos::RCP< Tpetra::CrsMatrix >(result SWIG_NO_NULL_DELETER_1) : NULL; - fresult.mem = SWIG_MOVE; - return fresult; -} - - -SWIGEXPORT SwigClassWrapper _wrap_new_TpetraCrsMatrix__SWIG_14(SwigClassWrapper const *farg1, SwigClassWrapper const *farg2, SwigArrayWrapper *farg3, int const *farg4) { - SwigClassWrapper fresult ; - Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > *arg1 = 0 ; - Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > *arg2 = 0 ; - Teuchos::ArrayView< std::size_t const > arg3 ; - Tpetra::ProfileType arg4 ; - Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > tempnull1 ; - Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > tempnull2 ; - Tpetra::CrsMatrix< SC,LO,GO,NO > *result = 0 ; - - arg1 = farg1->cptr ? static_cast< Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg1->cptr) : &tempnull1; - arg2 = farg2->cptr ? static_cast< Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg2->cptr) : &tempnull2; - arg3 = Teuchos::ArrayView(static_cast(farg3->data), farg3->size); - arg4 = static_cast< Tpetra::ProfileType >(*farg4); - { - // Make sure no unhandled exceptions exist before performing a new action - SWIG_check_unhandled_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::CrsMatrix(Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::ArrayView< std::size_t const >,Tpetra::ProfileType)");; - try - { - // Attempt the wrapped function call - result = (Tpetra::CrsMatrix< SC,LO,GO,NO > *)new_Tpetra_CrsMatrix_Sl_SC_Sc_LO_Sc_GO_Sc_NO_Sg___SWIG_13((Teuchos::RCP< Tpetra::Map< int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const > const &)*arg1,(Teuchos::RCP< Tpetra::Map< int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const > const &)*arg2,arg3,arg4); - } - catch (const std::range_error& e) - { - // Store a C++ exception - SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::CrsMatrix(Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::ArrayView< std::size_t const >,Tpetra::ProfileType)", SWIG_IndexError, e.what(), return SwigClassWrapper_uninitialized()); - } - catch (const std::exception& e) - { - // Store a C++ exception - SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::CrsMatrix(Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::ArrayView< std::size_t const >,Tpetra::ProfileType)", SWIG_RuntimeError, e.what(), return SwigClassWrapper_uninitialized()); - } - catch (...) - { - SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::CrsMatrix(Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::ArrayView< std::size_t const >,Tpetra::ProfileType)", SWIG_UnknownError, "An unknown exception occurred", return SwigClassWrapper_uninitialized()); - } - } - fresult.cptr = result ? new Teuchos::RCP< Tpetra::CrsMatrix >(result SWIG_NO_NULL_DELETER_1) : NULL; - fresult.mem = SWIG_MOVE; - return fresult; -} - - -SWIGEXPORT SwigClassWrapper _wrap_new_TpetraCrsMatrix__SWIG_15(SwigClassWrapper const *farg1, SwigClassWrapper const *farg2, SwigArrayWrapper *farg3) { - SwigClassWrapper fresult ; - Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > *arg1 = 0 ; - Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > *arg2 = 0 ; - Teuchos::ArrayView< std::size_t const > arg3 ; - Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > tempnull1 ; - Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > tempnull2 ; - Tpetra::CrsMatrix< SC,LO,GO,NO > *result = 0 ; - - arg1 = farg1->cptr ? static_cast< Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg1->cptr) : &tempnull1; - arg2 = farg2->cptr ? static_cast< Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg2->cptr) : &tempnull2; - arg3 = Teuchos::ArrayView(static_cast(farg3->data), farg3->size); - { - // Make sure no unhandled exceptions exist before performing a new action - SWIG_check_unhandled_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::CrsMatrix(Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::ArrayView< std::size_t const >)");; - try - { - // Attempt the wrapped function call - result = (Tpetra::CrsMatrix< SC,LO,GO,NO > *)new_Tpetra_CrsMatrix_Sl_SC_Sc_LO_Sc_GO_Sc_NO_Sg___SWIG_13((Teuchos::RCP< Tpetra::Map< int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const > const &)*arg1,(Teuchos::RCP< Tpetra::Map< int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const > const &)*arg2,arg3); - } - catch (const std::range_error& e) - { - // Store a C++ exception - SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::CrsMatrix(Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::ArrayView< std::size_t const >)", SWIG_IndexError, e.what(), return SwigClassWrapper_uninitialized()); - } - catch (const std::exception& e) - { - // Store a C++ exception - SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::CrsMatrix(Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::ArrayView< std::size_t const >)", SWIG_RuntimeError, e.what(), return SwigClassWrapper_uninitialized()); - } - catch (...) - { - SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::CrsMatrix(Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::ArrayView< std::size_t const >)", SWIG_UnknownError, "An unknown exception occurred", return SwigClassWrapper_uninitialized()); - } - } - fresult.cptr = result ? new Teuchos::RCP< Tpetra::CrsMatrix >(result SWIG_NO_NULL_DELETER_1) : NULL; - fresult.mem = SWIG_MOVE; - return fresult; -} - - -SWIGEXPORT SwigClassWrapper _wrap_new_TpetraCrsMatrix__SWIG_16(SwigClassWrapper const *farg1, SwigClassWrapper const *farg2, SwigArrayWrapper *farg3, SwigArrayWrapper *farg4, SwigArrayWrapper *farg5, SwigClassWrapper const *farg6) { - SwigClassWrapper fresult ; - Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > *arg1 = 0 ; - Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > *arg2 = 0 ; - Teuchos::ArrayView< std::size_t > arg3 ; - Teuchos::ArrayView< LO > arg4 ; - Teuchos::ArrayView< SC > arg5 ; - Teuchos::RCP< Teuchos::ParameterList > *arg6 = 0 ; - Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > tempnull1 ; - Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > tempnull2 ; - Teuchos::RCP< Teuchos::ParameterList > tempnull6 ; - Tpetra::CrsMatrix< SC,LO,GO,NO > *result = 0 ; - - arg1 = farg1->cptr ? static_cast< Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg1->cptr) : &tempnull1; - arg2 = farg2->cptr ? static_cast< Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg2->cptr) : &tempnull2; - arg3 = Teuchos::ArrayView(static_cast(farg3->data), farg3->size); - arg4 = Teuchos::ArrayView(static_cast(farg4->data), farg4->size); - arg5 = Teuchos::ArrayView(static_cast(farg5->data), farg5->size); - arg6 = farg6->cptr ? static_cast< Teuchos::RCP< Teuchos::ParameterList > * >(farg6->cptr) : &tempnull6; - { - // Make sure no unhandled exceptions exist before performing a new action - SWIG_check_unhandled_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::CrsMatrix(Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::ArrayView< std::size_t >,Teuchos::ArrayView< LO >,Teuchos::ArrayView< SC >,Teuchos::RCP< Teuchos::ParameterList > const &)");; - try - { - // Attempt the wrapped function call - result = (Tpetra::CrsMatrix< SC,LO,GO,NO > *)new_Tpetra_CrsMatrix_Sl_SC_Sc_LO_Sc_GO_Sc_NO_Sg___SWIG_16((Teuchos::RCP< Tpetra::Map< int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const > const &)*arg1,(Teuchos::RCP< Tpetra::Map< int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const > const &)*arg2,arg3,arg4,arg5,(Teuchos::RCP< Teuchos::ParameterList > const &)*arg6); - } - catch (const std::range_error& e) - { - // Store a C++ exception - SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::CrsMatrix(Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::ArrayView< std::size_t >,Teuchos::ArrayView< LO >,Teuchos::ArrayView< SC >,Teuchos::RCP< Teuchos::ParameterList > const &)", SWIG_IndexError, e.what(), return SwigClassWrapper_uninitialized()); - } - catch (const std::exception& e) - { - // Store a C++ exception - SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::CrsMatrix(Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::ArrayView< std::size_t >,Teuchos::ArrayView< LO >,Teuchos::ArrayView< SC >,Teuchos::RCP< Teuchos::ParameterList > const &)", SWIG_RuntimeError, e.what(), return SwigClassWrapper_uninitialized()); - } - catch (...) - { - SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::CrsMatrix(Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::ArrayView< std::size_t >,Teuchos::ArrayView< LO >,Teuchos::ArrayView< SC >,Teuchos::RCP< Teuchos::ParameterList > const &)", SWIG_UnknownError, "An unknown exception occurred", return SwigClassWrapper_uninitialized()); - } - } - fresult.cptr = result ? new Teuchos::RCP< Tpetra::CrsMatrix >(result SWIG_NO_NULL_DELETER_1) : NULL; - fresult.mem = SWIG_MOVE; - return fresult; -} - - -SWIGEXPORT SwigClassWrapper _wrap_new_TpetraCrsMatrix__SWIG_17(SwigClassWrapper const *farg1, SwigClassWrapper const *farg2, SwigArrayWrapper *farg3, SwigArrayWrapper *farg4, SwigArrayWrapper *farg5) { - SwigClassWrapper fresult ; - Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > *arg1 = 0 ; - Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > *arg2 = 0 ; - Teuchos::ArrayView< std::size_t > arg3 ; - Teuchos::ArrayView< LO > arg4 ; - Teuchos::ArrayView< SC > arg5 ; - Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > tempnull1 ; - Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > tempnull2 ; - Tpetra::CrsMatrix< SC,LO,GO,NO > *result = 0 ; - - arg1 = farg1->cptr ? static_cast< Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg1->cptr) : &tempnull1; - arg2 = farg2->cptr ? static_cast< Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > * >(farg2->cptr) : &tempnull2; - arg3 = Teuchos::ArrayView(static_cast(farg3->data), farg3->size); - arg4 = Teuchos::ArrayView(static_cast(farg4->data), farg4->size); - arg5 = Teuchos::ArrayView(static_cast(farg5->data), farg5->size); - { - // Make sure no unhandled exceptions exist before performing a new action - SWIG_check_unhandled_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::CrsMatrix(Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::ArrayView< std::size_t >,Teuchos::ArrayView< LO >,Teuchos::ArrayView< SC >)");; - try - { - // Attempt the wrapped function call - result = (Tpetra::CrsMatrix< SC,LO,GO,NO > *)new_Tpetra_CrsMatrix_Sl_SC_Sc_LO_Sc_GO_Sc_NO_Sg___SWIG_16((Teuchos::RCP< Tpetra::Map< int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const > const &)*arg1,(Teuchos::RCP< Tpetra::Map< int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const > const &)*arg2,arg3,arg4,arg5); - } - catch (const std::range_error& e) - { - // Store a C++ exception - SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::CrsMatrix(Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::ArrayView< std::size_t >,Teuchos::ArrayView< LO >,Teuchos::ArrayView< SC >)", SWIG_IndexError, e.what(), return SwigClassWrapper_uninitialized()); - } - catch (const std::exception& e) - { - // Store a C++ exception - SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::CrsMatrix(Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::ArrayView< std::size_t >,Teuchos::ArrayView< LO >,Teuchos::ArrayView< SC >)", SWIG_RuntimeError, e.what(), return SwigClassWrapper_uninitialized()); - } - catch (...) - { - SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::CrsMatrix(Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::ArrayView< std::size_t >,Teuchos::ArrayView< LO >,Teuchos::ArrayView< SC >)", SWIG_UnknownError, "An unknown exception occurred", return SwigClassWrapper_uninitialized()); - } - } - fresult.cptr = result ? new Teuchos::RCP< Tpetra::CrsMatrix >(result SWIG_NO_NULL_DELETER_1) : NULL; - fresult.mem = SWIG_MOVE; - return fresult; -} - - -SWIGEXPORT void _wrap_TpetraCrsMatrix_setAllValues(SwigClassWrapper const *farg1, SwigArrayWrapper *farg2, SwigArrayWrapper *farg3, SwigArrayWrapper *farg4) { - Tpetra::CrsMatrix< SC,LO,GO,NO > *arg1 = (Tpetra::CrsMatrix< SC,LO,GO,NO > *) 0 ; - Teuchos::ArrayView< std::size_t > arg2 ; - Teuchos::ArrayView< LO > arg3 ; - Teuchos::ArrayView< SC > arg4 ; - Teuchos::RCP< Tpetra::CrsMatrix< SC,LO,GO,NO > > *smartarg1 ; - - smartarg1 = static_cast< Teuchos::RCP< Tpetra::CrsMatrix >* >(farg1->cptr); - arg1 = smartarg1 ? const_cast< Tpetra::CrsMatrix* >(smartarg1->get()) : NULL; - arg2 = Teuchos::ArrayView(static_cast(farg2->data), farg2->size); - arg3 = Teuchos::ArrayView(static_cast(farg3->data), farg3->size); - arg4 = Teuchos::ArrayView(static_cast(farg4->data), farg4->size); - { - // Make sure no unhandled exceptions exist before performing a new action - SWIG_check_unhandled_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::setAllValues(Teuchos::ArrayView< std::size_t >,Teuchos::ArrayView< LO >,Teuchos::ArrayView< SC >)");; - try - { - // Attempt the wrapped function call - Tpetra_CrsMatrix_Sl_SC_Sc_LO_Sc_GO_Sc_NO_Sg__setAllValues(arg1,arg2,arg3,arg4); - } - catch (const std::range_error& e) - { - // Store a C++ exception - SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::setAllValues(Teuchos::ArrayView< std::size_t >,Teuchos::ArrayView< LO >,Teuchos::ArrayView< SC >)", SWIG_IndexError, e.what(), return ); - } - catch (const std::exception& e) - { - // Store a C++ exception - SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::setAllValues(Teuchos::ArrayView< std::size_t >,Teuchos::ArrayView< LO >,Teuchos::ArrayView< SC >)", SWIG_RuntimeError, e.what(), return ); - } - catch (...) - { - SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::setAllValues(Teuchos::ArrayView< std::size_t >,Teuchos::ArrayView< LO >,Teuchos::ArrayView< SC >)", SWIG_UnknownError, "An unknown exception occurred", return ); - } - } - -} - - SWIGEXPORT void _wrap_TpetraCrsMatrix_getAllValues(SwigClassWrapper const *farg1, SwigArrayWrapper *farg2, SwigArrayWrapper *farg3, SwigArrayWrapper *farg4) { Tpetra::CrsMatrix< SC,LO,GO,NO > *arg1 = (Tpetra::CrsMatrix< SC,LO,GO,NO > *) 0 ; Teuchos::ArrayView< std::size_t > arg2 ; From 0fe1f28e8d4a5d621a91b0d0bf036dc305b5a24d Mon Sep 17 00:00:00 2001 From: Seth R Johnson Date: Wed, 6 Feb 2019 13:40:48 -0500 Subject: [PATCH 30/40] Remove debug code --- src/teuchos/src/Teuchos_ArrayRCP.i | 40 ------ src/teuchos/src/swig/forteuchos.F90 | 126 +++++------------- .../src/swig/forteuchosFORTRAN_wrap.cxx | 116 ++++------------ 3 files changed, 60 insertions(+), 222 deletions(-) diff --git a/src/teuchos/src/Teuchos_ArrayRCP.i b/src/teuchos/src/Teuchos_ArrayRCP.i index 58131439..8c4ceb7f 100644 --- a/src/teuchos/src/Teuchos_ArrayRCP.i +++ b/src/teuchos/src/Teuchos_ArrayRCP.i @@ -19,21 +19,6 @@ class ArrayRCP typedef _Tp value_type; typedef std::size_t size_type; -#if 0 - // Rename 'call' operator to 'view' - %rename(view) operator(); - - // Add accessors to get a view - ArrayRCP<_Tp> operator()(size_type lowerOffset, size_type size) const; - ArrayRCP<_Tp> operator()() const; - - // Smart pointer attributes - int strong_count() const; - int weak_count() const; - int total_count() const; - bool has_ownership() const; -#endif - // Add native wrapping typemaps to convert *input* to Teuchos RCP %fortran_array_pointer(_Tp, ArrayRCP<_Tp>) %apply ArrayRCP<_Tp> { const ArrayRCP<_Tp> & } @@ -73,28 +58,3 @@ class ArrayRCP %template() Teuchos::ArrayRCP; %template() Teuchos::ArrayRCP; -#if 0 -%define %teuchos_template_arrayrcp(EXT, CPPTYPE) - -// Only instantiate non-const -%template(ArrayRCP ## EXT) Teuchos::ArrayRCP; - -// Use non-const typemaps for RCP-to-const -%apply Teuchos::ArrayRCP { Teuchos::ArrayRCP }; - -// Use arcp const cast to convert mutable to const -%typemap(in, noblock=1) Teuchos::ArrayRCP -(Teuchos::ArrayRCP* origrcp) { - SWIG_check_nonnull(*$input, "$1_ltype", "$fclassname", "$decl", return $null); - origrcp = %static_cast($input->cptr, Teuchos::ArrayRCP*); - $1 = Teuchos::arcp_const_cast(*origrcp); -} - -%enddef - -// Instantiate typemaps only -%template(ArrayRCP_Int) Teuchos::ArrayRCP; -%template(ArrayRCP_Dbl) Teuchos::ArrayRCP; -%template(ArrayRCP_Longlong) Teuchos::ArrayRCP; -#endif - diff --git a/src/teuchos/src/swig/forteuchos.F90 b/src/teuchos/src/swig/forteuchos.F90 index b85d3a61..bec87902 100644 --- a/src/teuchos/src/swig/forteuchos.F90 +++ b/src/teuchos/src/swig/forteuchos.F90 @@ -65,12 +65,6 @@ module forteuchos end enum integer, parameter, public :: TeuchosDataAccess = kind(TeuchosCopy) public :: TeuchosCopy, TeuchosView - type, bind(C) :: SwigArrayWrapper - type(C_PTR), public :: data = C_NULL_PTR - integer(C_SIZE_T), public :: size = 0 - end type - public :: value - public :: cref enum, bind(c) enumerator :: SWIG_NULL enumerator :: SWIG_OWN @@ -83,6 +77,10 @@ module forteuchos type(C_PTR), public :: cptr = C_NULL_PTR integer(C_INT), public :: mem = SWIG_NULL end type + type, bind(C) :: SwigArrayWrapper + type(C_PTR), public :: data = C_NULL_PTR + integer(C_SIZE_T), public :: size = 0 + end type ! class Teuchos::Array< int > type, public :: TeuchosArrayInt type(SwigClassWrapper), public :: swigdata @@ -175,20 +173,6 @@ module forteuchos ! WRAPPER DECLARATIONS interface -subroutine swigc_value(farg1) & -bind(C, name="_wrap_value") -use, intrinsic :: ISO_C_BINDING -import :: swigarraywrapper -type(SwigArrayWrapper) :: farg1 -end subroutine - -subroutine swigc_cref(farg1) & -bind(C, name="_wrap_cref") -use, intrinsic :: ISO_C_BINDING -import :: swigarraywrapper -type(SwigArrayWrapper) :: farg1 -end subroutine - function swigc_new_TeuchosArrayInt(farg1) & bind(C, name="_wrap_new_TeuchosArrayInt") & result(fresult) @@ -627,42 +611,6 @@ subroutine swigc_save_to_xml(farg1, farg2) & contains ! MODULE SUBPROGRAMS -subroutine value(a) -use, intrinsic :: ISO_C_BINDING -integer(C_INT), dimension(:), target :: a -integer(C_INT), pointer :: farg1_view - -type(SwigArrayWrapper) :: farg1 - -if (size(a) > 0) then -farg1_view => a(1) -farg1%data = c_loc(farg1_view) -farg1%size = size(a) -else -farg1%data = c_null_ptr -farg1%size = 0 -end if -call swigc_value(farg1) -end subroutine - -subroutine cref(a) -use, intrinsic :: ISO_C_BINDING -integer(C_INT), dimension(:), target :: a -integer(C_INT), pointer :: farg1_view - -type(SwigArrayWrapper) :: farg1 - -if (size(a) > 0) then -farg1_view => a(1) -farg1%data = c_loc(farg1_view) -farg1%size = size(a) -else -farg1%data = c_null_ptr -farg1%size = 0 -end if -call swigc_cref(farg1) -end subroutine - function new_TeuchosArrayInt(arg0) & result(self) use, intrinsic :: ISO_C_BINDING @@ -1060,13 +1008,13 @@ function swigf_ParameterList_sublist(self, name) & swig_result%swigdata = fresult end function -subroutine swigf_ParameterList_set__SWIG_1(self, name, value2) +subroutine swigf_ParameterList_set__SWIG_1(self, name, value) use, intrinsic :: ISO_C_BINDING class(ParameterList), intent(inout) :: self character(kind=C_CHAR, len=*), target :: name character(kind=C_CHAR), dimension(:), allocatable, target :: farg2_chars -real(C_DOUBLE), intent(in) :: value2 +real(C_DOUBLE), intent(in) :: value type(SwigClassWrapper) :: farg1 type(SwigArrayWrapper) :: farg2 @@ -1074,17 +1022,17 @@ subroutine swigf_ParameterList_set__SWIG_1(self, name, value2) farg1 = self%swigdata call SWIG_string_to_chararray(name, farg2_chars, farg2) -farg3 = value2 +farg3 = value call swigc_ParameterList_set__SWIG_1(farg1, farg2, farg3) end subroutine -subroutine swigf_ParameterList_set__SWIG_2(self, name, value2) +subroutine swigf_ParameterList_set__SWIG_2(self, name, value) use, intrinsic :: ISO_C_BINDING class(ParameterList), intent(inout) :: self character(kind=C_CHAR, len=*), target :: name character(kind=C_CHAR), dimension(:), allocatable, target :: farg2_chars -integer, intent(in) :: value2 +integer, intent(in) :: value type(SwigClassWrapper) :: farg1 type(SwigArrayWrapper) :: farg2 @@ -1092,17 +1040,17 @@ subroutine swigf_ParameterList_set__SWIG_2(self, name, value2) farg1 = self%swigdata call SWIG_string_to_chararray(name, farg2_chars, farg2) -farg3 = value2 +farg3 = value call swigc_ParameterList_set__SWIG_2(farg1, farg2, farg3) end subroutine -subroutine swigf_ParameterList_set__SWIG_3(self, name, value2) +subroutine swigf_ParameterList_set__SWIG_3(self, name, value) use, intrinsic :: ISO_C_BINDING class(ParameterList), intent(inout) :: self character(kind=C_CHAR, len=*), target :: name character(kind=C_CHAR), dimension(:), allocatable, target :: farg2_chars -integer(C_LONG_LONG), intent(in) :: value2 +integer(C_LONG_LONG), intent(in) :: value type(SwigClassWrapper) :: farg1 type(SwigArrayWrapper) :: farg2 @@ -1110,7 +1058,7 @@ subroutine swigf_ParameterList_set__SWIG_3(self, name, value2) farg1 = self%swigdata call SWIG_string_to_chararray(name, farg2_chars, farg2) -farg3 = value2 +farg3 = value call swigc_ParameterList_set__SWIG_3(farg1, farg2, farg3) end subroutine @@ -1127,13 +1075,13 @@ function SWIG_logical_to_int(inp) & end if end function -subroutine swigf_ParameterList_set__SWIG_4(self, name, value2) +subroutine swigf_ParameterList_set__SWIG_4(self, name, value) use, intrinsic :: ISO_C_BINDING class(ParameterList), intent(inout) :: self character(kind=C_CHAR, len=*), target :: name character(kind=C_CHAR), dimension(:), allocatable, target :: farg2_chars -logical, intent(in) :: value2 +logical, intent(in) :: value type(SwigClassWrapper) :: farg1 type(SwigArrayWrapper) :: farg2 @@ -1141,17 +1089,17 @@ subroutine swigf_ParameterList_set__SWIG_4(self, name, value2) farg1 = self%swigdata call SWIG_string_to_chararray(name, farg2_chars, farg2) -farg3 = SWIG_logical_to_int(value2) +farg3 = SWIG_logical_to_int(value) call swigc_ParameterList_set__SWIG_4(farg1, farg2, farg3) end subroutine -subroutine swigf_ParameterList_set__SWIG_5(self, name, value2) +subroutine swigf_ParameterList_set__SWIG_5(self, name, value) use, intrinsic :: ISO_C_BINDING class(ParameterList), intent(inout) :: self character(kind=C_CHAR, len=*), target :: name character(kind=C_CHAR), dimension(:), allocatable, target :: farg2_chars -character(kind=C_CHAR, len=*), target :: value2 +character(kind=C_CHAR, len=*), target :: value character(kind=C_CHAR), dimension(:), allocatable, target :: farg3_chars type(SwigClassWrapper) :: farg1 @@ -1160,17 +1108,17 @@ subroutine swigf_ParameterList_set__SWIG_5(self, name, value2) farg1 = self%swigdata call SWIG_string_to_chararray(name, farg2_chars, farg2) -call SWIG_string_to_chararray(value2, farg3_chars, farg3) +call SWIG_string_to_chararray(value, farg3_chars, farg3) call swigc_ParameterList_set__SWIG_5(farg1, farg2, farg3) end subroutine -subroutine swigf_ParameterList_set__SWIG_6(self, name, value2) +subroutine swigf_ParameterList_set__SWIG_6(self, name, value) use, intrinsic :: ISO_C_BINDING class(ParameterList), intent(inout) :: self character(kind=C_CHAR, len=*), target :: name character(kind=C_CHAR), dimension(:), allocatable, target :: farg2_chars -real(C_DOUBLE), dimension(:), target :: value2 +real(C_DOUBLE), dimension(:), target :: value real(C_DOUBLE), pointer :: farg3_view type(SwigClassWrapper) :: farg1 @@ -1179,10 +1127,10 @@ subroutine swigf_ParameterList_set__SWIG_6(self, name, value2) farg1 = self%swigdata call SWIG_string_to_chararray(name, farg2_chars, farg2) -if (size(value2) > 0) then -farg3_view => value2(1) +if (size(value) > 0) then +farg3_view => value(1) farg3%data = c_loc(farg3_view) -farg3%size = size(value2) +farg3%size = size(value) else farg3%data = c_null_ptr farg3%size = 0 @@ -1190,13 +1138,13 @@ subroutine swigf_ParameterList_set__SWIG_6(self, name, value2) call swigc_ParameterList_set__SWIG_6(farg1, farg2, farg3) end subroutine -subroutine swigf_ParameterList_set__SWIG_7(self, name, value2) +subroutine swigf_ParameterList_set__SWIG_7(self, name, value) use, intrinsic :: ISO_C_BINDING class(ParameterList), intent(inout) :: self character(kind=C_CHAR, len=*), target :: name character(kind=C_CHAR), dimension(:), allocatable, target :: farg2_chars -integer(C_INT), dimension(:), target :: value2 +integer(C_INT), dimension(:), target :: value integer(C_INT), pointer :: farg3_view type(SwigClassWrapper) :: farg1 @@ -1205,10 +1153,10 @@ subroutine swigf_ParameterList_set__SWIG_7(self, name, value2) farg1 = self%swigdata call SWIG_string_to_chararray(name, farg2_chars, farg2) -if (size(value2) > 0) then -farg3_view => value2(1) +if (size(value) > 0) then +farg3_view => value(1) farg3%data = c_loc(farg3_view) -farg3%size = size(value2) +farg3%size = size(value) else farg3%data = c_null_ptr farg3%size = 0 @@ -1216,13 +1164,13 @@ subroutine swigf_ParameterList_set__SWIG_7(self, name, value2) call swigc_ParameterList_set__SWIG_7(farg1, farg2, farg3) end subroutine -subroutine swigf_ParameterList_set__SWIG_8(self, name, value2) +subroutine swigf_ParameterList_set__SWIG_8(self, name, value) use, intrinsic :: ISO_C_BINDING class(ParameterList), intent(inout) :: self character(kind=C_CHAR, len=*), target :: name character(kind=C_CHAR), dimension(:), allocatable, target :: farg2_chars -integer(C_LONG_LONG), dimension(:), target :: value2 +integer(C_LONG_LONG), dimension(:), target :: value integer(C_LONG_LONG), pointer :: farg3_view type(SwigClassWrapper) :: farg1 @@ -1231,10 +1179,10 @@ subroutine swigf_ParameterList_set__SWIG_8(self, name, value2) farg1 = self%swigdata call SWIG_string_to_chararray(name, farg2_chars, farg2) -if (size(value2) > 0) then -farg3_view => value2(1) +if (size(value) > 0) then +farg3_view => value(1) farg3%data = c_loc(farg3_view) -farg3%size = size(value2) +farg3%size = size(value) else farg3%data = c_null_ptr farg3%size = 0 @@ -1242,13 +1190,13 @@ subroutine swigf_ParameterList_set__SWIG_8(self, name, value2) call swigc_ParameterList_set__SWIG_8(farg1, farg2, farg3) end subroutine -subroutine swigf_ParameterList_set__SWIG_9(self, name, value2) +subroutine swigf_ParameterList_set__SWIG_9(self, name, value) use, intrinsic :: ISO_C_BINDING class(ParameterList), intent(inout) :: self character(kind=C_CHAR, len=*), target :: name character(kind=C_CHAR), dimension(:), allocatable, target :: farg2_chars -class(ParameterList), intent(in) :: value2 +class(ParameterList), intent(in) :: value type(SwigClassWrapper) :: farg1 type(SwigArrayWrapper) :: farg2 @@ -1256,7 +1204,7 @@ subroutine swigf_ParameterList_set__SWIG_9(self, name, value2) farg1 = self%swigdata call SWIG_string_to_chararray(name, farg2_chars, farg2) -farg3 = value2%swigdata +farg3 = value%swigdata call swigc_ParameterList_set__SWIG_9(farg1, farg2, farg3) end subroutine diff --git a/src/teuchos/src/swig/forteuchosFORTRAN_wrap.cxx b/src/teuchos/src/swig/forteuchosFORTRAN_wrap.cxx index 60b8a307..44ce2891 100644 --- a/src/teuchos/src/swig/forteuchosFORTRAN_wrap.cxx +++ b/src/teuchos/src/swig/forteuchosFORTRAN_wrap.cxx @@ -293,9 +293,29 @@ struct assignment_flags; #include "Teuchos_ArrayRCP.hpp" -namespace Teuchos { -void value(Teuchos::ArrayRCP a) { } -void cref(const Teuchos::ArrayRCP& a) { } +#include "Teuchos_Array.hpp" + + +enum SwigMemState { + SWIG_NULL, + SWIG_OWN, + SWIG_MOVE, + SWIG_REF, + SWIG_CREF +}; + + +struct SwigClassWrapper { + void* cptr; + SwigMemState mem; +}; + + +SWIGINTERN SwigClassWrapper SwigClassWrapper_uninitialized() { + SwigClassWrapper result; + result.cptr = NULL; + result.mem = SWIG_NULL; + return result; } @@ -323,32 +343,6 @@ SWIGINTERN SwigArrayWrapper SwigArrayWrapper_uninitialized() { return result; } - -#include "Teuchos_Array.hpp" - - -enum SwigMemState { - SWIG_NULL, - SWIG_OWN, - SWIG_MOVE, - SWIG_REF, - SWIG_CREF -}; - - -struct SwigClassWrapper { - void* cptr; - SwigMemState mem; -}; - - -SWIGINTERN SwigClassWrapper SwigClassWrapper_uninitialized() { - SwigClassWrapper result; - result.cptr = NULL; - result.mem = SWIG_NULL; - return result; -} - SWIGINTERN Teuchos::ArrayView< int > Teuchos_Array_Sl_int_Sg__view(Teuchos::Array< int > *self){ return (*self)(); } @@ -650,70 +644,6 @@ void save_to_xml(const Teuchos::ParameterList& plist, #ifdef __cplusplus extern "C" { #endif -SWIGEXPORT void _wrap_value(SwigArrayWrapper *farg1) { - Teuchos::ArrayRCP< int > arg1 ; - - arg1 = Teuchos::ArrayRCP(static_cast(farg1->data), 0, farg1->size, false, Teuchos::RCP_DISABLE_NODE_LOOKUP); - { - // Make sure no unhandled exceptions exist before performing a new action - SWIG_check_unhandled_exception_impl("Teuchos::value(Teuchos::ArrayRCP< int >)");; - try - { - // Attempt the wrapped function call - Teuchos::value(arg1); - } - catch (const std::range_error& e) - { - // Store a C++ exception - SWIG_exception_impl("Teuchos::value(Teuchos::ArrayRCP< int >)", SWIG_IndexError, e.what(), return ); - } - catch (const std::exception& e) - { - // Store a C++ exception - SWIG_exception_impl("Teuchos::value(Teuchos::ArrayRCP< int >)", SWIG_RuntimeError, e.what(), return ); - } - catch (...) - { - SWIG_exception_impl("Teuchos::value(Teuchos::ArrayRCP< int >)", SWIG_UnknownError, "An unknown exception occurred", return ); - } - } - -} - - -SWIGEXPORT void _wrap_cref(SwigArrayWrapper *farg1) { - Teuchos::ArrayRCP< int > *arg1 = 0 ; - Teuchos::ArrayRCP< int > tmparr1 ; - - tmparr1 = Teuchos::ArrayRCP(static_cast(farg1->data), 0, farg1->size, false, Teuchos::RCP_DISABLE_NODE_LOOKUP); - arg1 = &tmparr1; - { - // Make sure no unhandled exceptions exist before performing a new action - SWIG_check_unhandled_exception_impl("Teuchos::cref(Teuchos::ArrayRCP< int > const &)");; - try - { - // Attempt the wrapped function call - Teuchos::cref((Teuchos::ArrayRCP< int > const &)*arg1); - } - catch (const std::range_error& e) - { - // Store a C++ exception - SWIG_exception_impl("Teuchos::cref(Teuchos::ArrayRCP< int > const &)", SWIG_IndexError, e.what(), return ); - } - catch (const std::exception& e) - { - // Store a C++ exception - SWIG_exception_impl("Teuchos::cref(Teuchos::ArrayRCP< int > const &)", SWIG_RuntimeError, e.what(), return ); - } - catch (...) - { - SWIG_exception_impl("Teuchos::cref(Teuchos::ArrayRCP< int > const &)", SWIG_UnknownError, "An unknown exception occurred", return ); - } - } - -} - - SWIGEXPORT SwigClassWrapper _wrap_new_TeuchosArrayInt(SwigArrayWrapper *farg1) { SwigClassWrapper fresult ; Teuchos::ArrayView< int const > *arg1 = 0 ; From 4889bd1b8602f281d8773a2ea5fc03255245bf20 Mon Sep 17 00:00:00 2001 From: Seth R Johnson Date: Thu, 7 Feb 2019 12:49:34 -0500 Subject: [PATCH 31/40] Add check for non-null pointer when taking ArrayView& Also clearing initial pointer assignments in the test. --- src/tpetra/src/swig/fortpetra.F90 | 4 ++-- src/tpetra/test/test_tpetra_crsmatrix.F90 | 4 ++-- swig_hash | 2 +- 3 files changed, 5 insertions(+), 5 deletions(-) diff --git a/src/tpetra/src/swig/fortpetra.F90 b/src/tpetra/src/swig/fortpetra.F90 index 522f1c2f..f8cfbe03 100644 --- a/src/tpetra/src/swig/fortpetra.F90 +++ b/src/tpetra/src/swig/fortpetra.F90 @@ -10545,14 +10545,14 @@ subroutine swigf_TpetraCrsMatrix_getGlobalRowView(self, globalrow, indices, valu farg1 = self%swigdata farg2 = globalrow -if (size(indices) > 0) then +if (associated(indices) .and. size(indices) > 0) then farg3%data = c_loc(indices) farg3%size = size(indices) else farg3%data = c_null_ptr farg3%size = 0 end if -if (size(values) > 0) then +if (associated(values) .and. size(values) > 0) then farg4%data = c_loc(values) farg4%size = size(values) else diff --git a/src/tpetra/test/test_tpetra_crsmatrix.F90 b/src/tpetra/test/test_tpetra_crsmatrix.F90 index be9e1d59..a819bbe3 100644 --- a/src/tpetra/test/test_tpetra_crsmatrix.F90 +++ b/src/tpetra/test/test_tpetra_crsmatrix.F90 @@ -603,8 +603,8 @@ program test_TpetraCrsMatrix real(scalar_type) :: scopy(4) integer :: lcopy(4) integer(global_ordinal_type) :: gcopy(4) - integer(global_ordinal_type), pointer :: cgptr(:) - real(scalar_type), pointer :: csptr(:) + integer(global_ordinal_type), pointer :: cgptr(:) => NULL() + real(scalar_type), pointer :: csptr(:) => NULL() integer(global_ordinal_type) :: gblrow integer, allocatable :: linds(:) integer(global_ordinal_type), allocatable :: ginds(:), mask(:) diff --git a/swig_hash b/swig_hash index 729c09d0..f0c3ced0 100644 --- a/swig_hash +++ b/swig_hash @@ -1 +1 @@ -cefd405afbacffd4c8932d1d748ed490bd5381fe +a7ee77f2760b7db3962f091b36407d544e7f0037 From 8ae8a947e05e7cd9a1751f49bce5226c6ac58fa1 Mon Sep 17 00:00:00 2001 From: Seth R Johnson Date: Mon, 11 Feb 2019 21:31:36 -0500 Subject: [PATCH 32/40] Fix binding type error noticed by latest swig --- src/interface/src/nox.i | 2 +- 1 file changed, 1 insertion(+), 1 deletion(-) diff --git a/src/interface/src/nox.i b/src/interface/src/nox.i index 5521c208..1cb62853 100644 --- a/src/interface/src/nox.i +++ b/src/interface/src/nox.i @@ -348,7 +348,7 @@ function swigd_ForModelEvaluator_create_operator(fself) & type(SwigClassWrapper) :: fresult class(ForModelEvaluator), pointer :: self - type(ForTpetraOperator) :: result + type(TpetraOperator) :: result ! Get pointer to Fortran object from class Handle call c_f_pointer_ForModelEvaluator(fself, self) From 11b247639f801b30ed1c4a52b0231af4fb238848 Mon Sep 17 00:00:00 2001 From: Seth R Johnson Date: Mon, 11 Feb 2019 21:31:59 -0500 Subject: [PATCH 33/40] Update for latest SWIG - Changes intent of mutable classes to intent(in) since we only modify the pointed-to-class, not the pointer - Fixes modification of "other" pointer during assignment, which would access possibly off-limits Fortran memory --- src/belos/src/swig/forbelos.F90 | 48 +- src/belos/src/swig/forbelosFORTRAN_wrap.cxx | 49 +- src/interface/src/swig/fortrilinos.F90 | 349 ++- .../src/swig/fortrilinosFORTRAN_wrap.cxx | 292 ++- .../test/Tpetra_ModelEvaluator_1DFEM.F90 | 6 +- src/interface/test/test_solver_handle.F90 | 2 +- src/teuchos/src/swig/forteuchos.F90 | 361 ++- .../src/swig/forteuchosFORTRAN_wrap.cxx | 230 +- src/tpetra/src/swig/fortpetra.F90 | 2115 ++++++----------- src/tpetra/src/swig/fortpetraFORTRAN_wrap.cxx | 599 +++-- src/utils/src/swig/forerror.F90 | 1 - swig_hash | 2 +- 12 files changed, 1855 insertions(+), 2199 deletions(-) diff --git a/src/belos/src/swig/forbelos.F90 b/src/belos/src/swig/forbelos.F90 index 4b3033dc..a48f9153 100644 --- a/src/belos/src/swig/forbelos.F90 +++ b/src/belos/src/swig/forbelos.F90 @@ -138,8 +138,8 @@ module forbelos type(SwigClassWrapper), public :: swigdata contains procedure :: release => delete_DefaultSolverParameters - procedure, private :: swigf_assignment_DefaultSolverParameters - generic :: assignment(=) => swigf_assignment_DefaultSolverParameters + procedure, private :: swigf_DefaultSolverParameters_op_assign__ + generic :: assignment(=) => swigf_DefaultSolverParameters_op_assign__ end type DefaultSolverParameters interface DefaultSolverParameters module procedure new_DefaultSolverParameters @@ -218,16 +218,17 @@ subroutine swigc_delete_DefaultSolverParameters(farg1) & bind(C, name="_wrap_delete_DefaultSolverParameters") use, intrinsic :: ISO_C_BINDING import :: swigclasswrapper -type(SwigClassWrapper) :: farg1 +type(SwigClassWrapper), intent(inout) :: farg1 +end subroutine + +subroutine swigc_DefaultSolverParameters_op_assign__(farg1, farg2) & +bind(C, name="_wrap_DefaultSolverParameters_op_assign__") +use, intrinsic :: ISO_C_BINDING +import :: swigclasswrapper +type(SwigClassWrapper), intent(inout) :: farg1 +type(SwigClassWrapper) :: farg2 end subroutine - subroutine swigc_assignment_DefaultSolverParameters(self, other) & - bind(C, name="_wrap_assign_DefaultSolverParameters") - use, intrinsic :: ISO_C_BINDING - import :: SwigClassWrapper - type(SwigClassWrapper), intent(inout) :: self - type(SwigClassWrapper), intent(in) :: other - end subroutine end interface @@ -252,7 +253,6 @@ function convertReturnTypeToString(result) & use, intrinsic :: ISO_C_BINDING character(kind=C_CHAR, len=:), allocatable :: swig_result integer(BelosReturnType), intent(in) :: result - type(SwigArrayWrapper) :: fresult integer(C_INT) :: farg1 @@ -267,7 +267,6 @@ function convertStatusTypeToString(status) & use, intrinsic :: ISO_C_BINDING character(kind=C_CHAR, len=:), allocatable :: swig_result integer(BelosStatusType), intent(in) :: status - type(SwigArrayWrapper) :: fresult integer(C_INT) :: farg1 @@ -301,7 +300,6 @@ function convertStringToStatusType(status) & integer(BelosStatusType) :: swig_result character(kind=C_CHAR, len=*), target :: status character(kind=C_CHAR), dimension(:), allocatable, target :: farg1_chars - integer(C_INT) :: fresult type(SwigArrayWrapper) :: farg1 @@ -316,7 +314,6 @@ function convertStringToScaleType(scaletype) & integer(BelosScaleType) :: swig_result character(kind=C_CHAR, len=*), target :: scaletype character(kind=C_CHAR), dimension(:), allocatable, target :: farg1_chars - integer(C_INT) :: fresult type(SwigArrayWrapper) :: farg1 @@ -330,7 +327,6 @@ function convertScaleTypeToString(scaletype) & use, intrinsic :: ISO_C_BINDING character(kind=C_CHAR, len=:), allocatable :: swig_result integer(BelosScaleType), intent(in) :: scaletype - type(SwigArrayWrapper) :: fresult integer(C_INT) :: farg1 @@ -345,7 +341,6 @@ function convertMsgTypeToString(msgtype) & use, intrinsic :: ISO_C_BINDING character(kind=C_CHAR, len=:), allocatable :: swig_result integer(BelosMsgType), intent(in) :: msgtype - type(SwigArrayWrapper) :: fresult integer(C_INT) :: farg1 @@ -359,7 +354,6 @@ function new_DefaultSolverParameters() & result(self) use, intrinsic :: ISO_C_BINDING type(DefaultSolverParameters) :: self - type(SwigClassWrapper) :: fresult fresult = swigc_new_DefaultSolverParameters() @@ -369,7 +363,6 @@ function new_DefaultSolverParameters() & subroutine delete_DefaultSolverParameters(self) use, intrinsic :: ISO_C_BINDING class(DefaultSolverParameters), intent(inout) :: self - type(SwigClassWrapper) :: farg1 farg1 = self%swigdata @@ -380,11 +373,18 @@ subroutine delete_DefaultSolverParameters(self) self%swigdata%mem = SWIG_NULL end subroutine - subroutine swigf_assignment_DefaultSolverParameters(self, other) - use, intrinsic :: ISO_C_BINDING - class(DefaultSolverParameters), intent(inout) :: self - type(DefaultSolverParameters), intent(in) :: other - call swigc_assignment_DefaultSolverParameters(self%swigdata, other%swigdata) - end subroutine +subroutine swigf_DefaultSolverParameters_op_assign__(self, other) +use, intrinsic :: ISO_C_BINDING +class(DefaultSolverParameters), intent(inout) :: self +type(DefaultSolverParameters), intent(in) :: other +type(SwigClassWrapper) :: farg1 +type(SwigClassWrapper) :: farg2 + +farg1 = self%swigdata +farg2 = other%swigdata +call swigc_DefaultSolverParameters_op_assign__(farg1, farg2) +self%swigdata = farg1 +end subroutine + end module diff --git a/src/belos/src/swig/forbelosFORTRAN_wrap.cxx b/src/belos/src/swig/forbelosFORTRAN_wrap.cxx index 30e22fc4..635f0c2a 100644 --- a/src/belos/src/swig/forbelosFORTRAN_wrap.cxx +++ b/src/belos/src/swig/forbelosFORTRAN_wrap.cxx @@ -205,28 +205,6 @@ void SWIG_store_exception(const char* decl, int errcode, const char *msg); SWIG_store_exception(DECL, CODE, MSG); RETURNNULL; -#define SWIG_check_mutable(SWIG_CLASS_WRAPPER, TYPENAME, FNAME, FUNCNAME, RETURNNULL) \ - if ((SWIG_CLASS_WRAPPER).mem == SWIG_CREF) { \ - SWIG_exception_impl(FUNCNAME, SWIG_TypeError, \ - "Cannot pass const " TYPENAME " (class " FNAME ") " \ - "as a mutable reference", \ - RETURNNULL); \ - } - - -#define SWIG_check_nonnull(SWIG_CLASS_WRAPPER, TYPENAME, FNAME, FUNCNAME, RETURNNULL) \ - if ((SWIG_CLASS_WRAPPER).mem == SWIG_NULL) { \ - SWIG_exception_impl(FUNCNAME, SWIG_TypeError, \ - "Cannot pass null " TYPENAME " (class " FNAME ") " \ - "as a reference", RETURNNULL); \ - } - - -#define SWIG_check_mutable_nonnull(SWIG_CLASS_WRAPPER, TYPENAME, FNAME, FUNCNAME, RETURNNULL) \ - SWIG_check_nonnull(SWIG_CLASS_WRAPPER, TYPENAME, FNAME, FUNCNAME, RETURNNULL); \ - SWIG_check_mutable(SWIG_CLASS_WRAPPER, TYPENAME, FNAME, FUNCNAME, RETURNNULL); - - namespace swig { enum AssignmentFlags { @@ -243,7 +221,7 @@ struct assignment_flags; #define SWIG_assign(LEFTTYPE, LEFT, RIGHTTYPE, RIGHT, FLAGS) \ - SWIG_assign_impl::value >(LEFT, RIGHT); + SWIG_assign_impl::value >(LEFT, RIGHT); #include @@ -458,7 +436,7 @@ struct AssignmentTraits { template -SWIGINTERN void SWIG_assign_impl(SwigClassWrapper* self, SwigClassWrapper* other) { +SWIGINTERN void SWIG_assign_impl(SwigClassWrapper* self, const SwigClassWrapper* other) { typedef swig::AssignmentTraits Traits_t; T1* pself = static_cast(self->cptr); T2* pother = static_cast(other->cptr); @@ -471,9 +449,7 @@ SWIGINTERN void SWIG_assign_impl(SwigClassWrapper* self, SwigClassWrapper* other break; case SWIG_MOVE: /* capture pointer from RHS */ self->cptr = other->cptr; - other->cptr = NULL; self->mem = SWIG_OWN; - other->mem = SWIG_NULL; break; case SWIG_OWN: /* copy from RHS */ self->cptr = Traits_t::copy_construct(pother); @@ -499,8 +475,6 @@ SWIGINTERN void SWIG_assign_impl(SwigClassWrapper* self, SwigClassWrapper* other /* Move RHS into LHS; delete RHS */ Traits_t::move_assign(pself, pother); Traits_t::destruct(pother); - other->cptr = NULL; - other->mem = SWIG_NULL; break; case SWIG_OWN: case SWIG_REF: @@ -528,8 +502,6 @@ SWIGINTERN void SWIG_assign_impl(SwigClassWrapper* self, SwigClassWrapper* other * same. */ Traits_t::move_assign(pself, pother); Traits_t::destruct(pother); - other->cptr = NULL; - other->mem = SWIG_NULL; break; case SWIG_OWN: case SWIG_REF: @@ -705,21 +677,22 @@ SWIGEXPORT SwigClassWrapper _wrap_new_DefaultSolverParameters() { } -SWIGEXPORT void _wrap_delete_DefaultSolverParameters(SwigClassWrapper const *farg1) { +SWIGEXPORT void _wrap_delete_DefaultSolverParameters(SwigClassWrapper *farg1) { Belos::DefaultSolverParameters *arg1 = (Belos::DefaultSolverParameters *) 0 ; - SWIG_check_mutable_nonnull(*farg1, "Belos::DefaultSolverParameters *", "DefaultSolverParameters", "Belos::DefaultSolverParameters::~DefaultSolverParameters()", return ); - arg1 = static_cast< Belos::DefaultSolverParameters * >(farg1->cptr); + (void)sizeof(farg1); delete arg1; - } -SWIGEXPORT void _wrap_assign_DefaultSolverParameters(SwigClassWrapper * self, SwigClassWrapper const * other) { +SWIGEXPORT void _wrap_DefaultSolverParameters_op_assign__(SwigClassWrapper *farg1, SwigClassWrapper const *farg2) { + Belos::DefaultSolverParameters *arg1 = (Belos::DefaultSolverParameters *) 0 ; + Belos::DefaultSolverParameters *arg2 = 0 ; + + (void)sizeof(arg1); + (void)sizeof(arg2); typedef Belos::DefaultSolverParameters swig_lhs_classtype; - SWIG_assign(swig_lhs_classtype, self, - swig_lhs_classtype, const_cast(other), - 0 | swig::IS_DESTR | swig::IS_COPY_CONSTR); + SWIG_assign(swig_lhs_classtype, farg1, swig_lhs_classtype, farg2, 0 | swig::IS_DESTR | swig::IS_COPY_CONSTR); } diff --git a/src/interface/src/swig/fortrilinos.F90 b/src/interface/src/swig/fortrilinos.F90 index 99709caa..3126fa87 100644 --- a/src/interface/src/swig/fortrilinos.F90 +++ b/src/interface/src/swig/fortrilinos.F90 @@ -34,17 +34,17 @@ module fortrilinos type, public :: TrilinosSolver type(SwigClassWrapper), public :: swigdata contains - procedure, private :: init__SWIG_0 => swigf_TrilinosSolver_init__SWIG_0 - procedure, private :: init__SWIG_1 => swigf_TrilinosSolver_init__SWIG_1 + procedure, private :: swigf_TrilinosSolver_op_assign__ + procedure, private :: swigf_TrilinosSolver_init__SWIG_0 + procedure, private :: swigf_TrilinosSolver_init__SWIG_1 procedure :: setup_matrix => swigf_TrilinosSolver_setup_matrix procedure :: setup_operator => swigf_TrilinosSolver_setup_operator procedure :: setup_solver => swigf_TrilinosSolver_setup_solver procedure :: solve => swigf_TrilinosSolver_solve procedure :: finalize => swigf_TrilinosSolver_finalize procedure :: release => delete_TrilinosSolver - procedure, private :: swigf_assignment_TrilinosSolver - generic :: init => init__SWIG_0, init__SWIG_1 - generic :: assignment(=) => swigf_assignment_TrilinosSolver + generic :: assignment(=) => swigf_TrilinosSolver_op_assign__ + generic :: init => swigf_TrilinosSolver_init__SWIG_0, swigf_TrilinosSolver_init__SWIG_1 end type TrilinosSolver interface TrilinosSolver module procedure new_TrilinosSolver @@ -57,8 +57,9 @@ module fortrilinos type, public :: TrilinosEigenSolver type(SwigClassWrapper), public :: swigdata contains - procedure, private :: init__SWIG_0 => swigf_TrilinosEigenSolver_init__SWIG_0 - procedure, private :: init__SWIG_1 => swigf_TrilinosEigenSolver_init__SWIG_1 + procedure, private :: swigf_TrilinosEigenSolver_op_assign__ + procedure, private :: swigf_TrilinosEigenSolver_init__SWIG_0 + procedure, private :: swigf_TrilinosEigenSolver_init__SWIG_1 procedure :: setup_matrix => swigf_TrilinosEigenSolver_setup_matrix procedure :: setup_matrix_rhs => swigf_TrilinosEigenSolver_setup_matrix_rhs procedure :: setup_operator => swigf_TrilinosEigenSolver_setup_operator @@ -67,13 +68,15 @@ module fortrilinos procedure :: solve => swigf_TrilinosEigenSolver_solve procedure :: finalize => swigf_TrilinosEigenSolver_finalize procedure :: release => delete_TrilinosEigenSolver - procedure, private :: swigf_assignment_TrilinosEigenSolver - generic :: init => init__SWIG_0, init__SWIG_1 - generic :: assignment(=) => swigf_assignment_TrilinosEigenSolver + generic :: assignment(=) => swigf_TrilinosEigenSolver_op_assign__ + generic :: init => swigf_TrilinosEigenSolver_init__SWIG_0, swigf_TrilinosEigenSolver_init__SWIG_1 end type TrilinosEigenSolver interface TrilinosEigenSolver module procedure new_TrilinosEigenSolver end interface + type, public :: SWIGTYPE_ForTrilinos__ModelEvaluatorT_SC_LO_GO_NO_t + type(SwigClassWrapper), public :: swigdata + end type ! class ForTrilinos::ModelEvaluator< SC,LO,GO,NO > type, public :: ForTrilinosModelEvaluator type(SwigClassWrapper), public :: swigdata @@ -86,8 +89,8 @@ module fortrilinos procedure :: create_operator => swigf_ForTrilinosModelEvaluator_create_operator procedure :: setup => swigf_ForTrilinosModelEvaluator_setup procedure :: release => delete_ForTrilinosModelEvaluator - procedure, private :: swigf_assignment_ForTrilinosModelEvaluator - generic :: assignment(=) => swigf_assignment_ForTrilinosModelEvaluator + procedure, private :: swigf_ForTrilinosModelEvaluator_op_assign__ + generic :: assignment(=) => swigf_ForTrilinosModelEvaluator_op_assign__ end type ForTrilinosModelEvaluator ! class ForModelEvaluator type, extends(ForTrilinosModelEvaluator), public :: ForModelEvaluator @@ -102,8 +105,8 @@ module fortrilinos procedure :: get_f_map => swigf_ForModelEvaluator_get_f_map procedure :: create_operator => swigf_ForModelEvaluator_create_operator procedure :: release => delete_ForModelEvaluator - procedure, private :: swigf_assignment_ForModelEvaluator - generic :: assignment(=) => swigf_assignment_ForModelEvaluator + procedure, private :: swigf_ForModelEvaluator_op_assign__ + generic :: assignment(=) => swigf_ForModelEvaluator_op_assign__ end type ForModelEvaluator interface ForModelEvaluator module procedure new_ForModelEvaluator @@ -117,6 +120,9 @@ module fortrilinos public :: init_ForModelEvaluator integer, parameter, public :: SWIGTYPE_NOX__StatusTest__StatusType = C_INT + type, public :: SWIGTYPE_ForTrilinos__NOXSolverT_SC_LO_GO_NO_t + type(SwigClassWrapper), public :: swigdata + end type ! class ForTrilinos::NOXSolver< SC,LO,GO,NO > type, public :: NOXSolver type(SwigClassWrapper), public :: swigdata @@ -124,8 +130,8 @@ module fortrilinos procedure :: setup => swigf_NOXSolver_setup procedure :: solve => swigf_NOXSolver_solve procedure :: release => delete_NOXSolver - procedure, private :: swigf_assignment_NOXSolver - generic :: assignment(=) => swigf_assignment_NOXSolver + procedure, private :: swigf_NOXSolver_op_assign__ + generic :: assignment(=) => swigf_NOXSolver_op_assign__ end type NOXSolver interface NOXSolver module procedure new_NOXSolver @@ -158,6 +164,14 @@ function swigc_new_TrilinosSolver() & type(SwigClassWrapper) :: fresult end function +subroutine swigc_TrilinosSolver_op_assign__(farg1, farg2) & +bind(C, name="_wrap_TrilinosSolver_op_assign__") +use, intrinsic :: ISO_C_BINDING +import :: swigclasswrapper +type(SwigClassWrapper), intent(inout) :: farg1 +type(SwigClassWrapper) :: farg2 +end subroutine + subroutine swigc_TrilinosSolver_init__SWIG_0(farg1) & bind(C, name="_wrap_TrilinosSolver_init__SWIG_0") use, intrinsic :: ISO_C_BINDING @@ -217,16 +231,9 @@ subroutine swigc_delete_TrilinosSolver(farg1) & bind(C, name="_wrap_delete_TrilinosSolver") use, intrinsic :: ISO_C_BINDING import :: swigclasswrapper -type(SwigClassWrapper) :: farg1 +type(SwigClassWrapper), intent(inout) :: farg1 end subroutine - subroutine swigc_assignment_TrilinosSolver(self, other) & - bind(C, name="_wrap_assign_TrilinosSolver") - use, intrinsic :: ISO_C_BINDING - import :: SwigClassWrapper - type(SwigClassWrapper), intent(inout) :: self - type(SwigClassWrapper), intent(in) :: other - end subroutine function swigc_new_TrilinosEigenSolver() & bind(C, name="_wrap_new_TrilinosEigenSolver") & result(fresult) @@ -235,6 +242,14 @@ function swigc_new_TrilinosEigenSolver() & type(SwigClassWrapper) :: fresult end function +subroutine swigc_TrilinosEigenSolver_op_assign__(farg1, farg2) & +bind(C, name="_wrap_TrilinosEigenSolver_op_assign__") +use, intrinsic :: ISO_C_BINDING +import :: swigclasswrapper +type(SwigClassWrapper), intent(inout) :: farg1 +type(SwigClassWrapper) :: farg2 +end subroutine + subroutine swigc_TrilinosEigenSolver_init__SWIG_0(farg1) & bind(C, name="_wrap_TrilinosEigenSolver_init__SWIG_0") use, intrinsic :: ISO_C_BINDING @@ -314,16 +329,9 @@ subroutine swigc_delete_TrilinosEigenSolver(farg1) & bind(C, name="_wrap_delete_TrilinosEigenSolver") use, intrinsic :: ISO_C_BINDING import :: swigclasswrapper -type(SwigClassWrapper) :: farg1 +type(SwigClassWrapper), intent(inout) :: farg1 end subroutine - subroutine swigc_assignment_TrilinosEigenSolver(self, other) & - bind(C, name="_wrap_assign_TrilinosEigenSolver") - use, intrinsic :: ISO_C_BINDING - import :: SwigClassWrapper - type(SwigClassWrapper), intent(inout) :: self - type(SwigClassWrapper), intent(in) :: other - end subroutine subroutine swigc_ForTrilinosModelEvaluator_evaluate_residual(farg1, farg2, farg3) & bind(C, name="_wrap_ForTrilinosModelEvaluator_evaluate_residual") use, intrinsic :: ISO_C_BINDING @@ -390,16 +398,17 @@ subroutine swigc_delete_ForTrilinosModelEvaluator(farg1) & bind(C, name="_wrap_delete_ForTrilinosModelEvaluator") use, intrinsic :: ISO_C_BINDING import :: swigclasswrapper -type(SwigClassWrapper) :: farg1 +type(SwigClassWrapper), intent(inout) :: farg1 +end subroutine + +subroutine swigc_ForTrilinosModelEvaluator_op_assign__(farg1, farg2) & +bind(C, name="_wrap_ForTrilinosModelEvaluator_op_assign__") +use, intrinsic :: ISO_C_BINDING +import :: swigclasswrapper +type(SwigClassWrapper), intent(inout) :: farg1 +type(SwigClassWrapper) :: farg2 end subroutine - subroutine swigc_assignment_ForTrilinosModelEvaluator(self, other) & - bind(C, name="_wrap_assign_ForTrilinosModelEvaluator") - use, intrinsic :: ISO_C_BINDING - import :: SwigClassWrapper - type(SwigClassWrapper), intent(inout) :: self - type(SwigClassWrapper), intent(in) :: other - end subroutine function swigc_ForModelEvaluator_fhandle(farg1) & bind(C, name="_wrap_ForModelEvaluator_fhandle") & result(fresult) @@ -491,16 +500,17 @@ subroutine swigc_delete_ForModelEvaluator(farg1) & bind(C, name="_wrap_delete_ForModelEvaluator") use, intrinsic :: ISO_C_BINDING import :: swigclasswrapper -type(SwigClassWrapper) :: farg1 +type(SwigClassWrapper), intent(inout) :: farg1 +end subroutine + +subroutine swigc_ForModelEvaluator_op_assign__(farg1, farg2) & +bind(C, name="_wrap_ForModelEvaluator_op_assign__") +use, intrinsic :: ISO_C_BINDING +import :: swigclasswrapper +type(SwigClassWrapper), intent(inout) :: farg1 +type(SwigClassWrapper) :: farg2 end subroutine - subroutine swigc_assignment_ForModelEvaluator(self, other) & - bind(C, name="_wrap_assign_ForModelEvaluator") - use, intrinsic :: ISO_C_BINDING - import :: SwigClassWrapper - type(SwigClassWrapper), intent(inout) :: self - type(SwigClassWrapper), intent(in) :: other - end subroutine function swigc_new_NOXSolver(farg1) & bind(C, name="_wrap_new_NOXSolver") & result(fresult) @@ -531,16 +541,17 @@ subroutine swigc_delete_NOXSolver(farg1) & bind(C, name="_wrap_delete_NOXSolver") use, intrinsic :: ISO_C_BINDING import :: swigclasswrapper -type(SwigClassWrapper) :: farg1 +type(SwigClassWrapper), intent(inout) :: farg1 +end subroutine + +subroutine swigc_NOXSolver_op_assign__(farg1, farg2) & +bind(C, name="_wrap_NOXSolver_op_assign__") +use, intrinsic :: ISO_C_BINDING +import :: swigclasswrapper +type(SwigClassWrapper), intent(inout) :: farg1 +type(SwigClassWrapper) :: farg2 end subroutine - subroutine swigc_assignment_NOXSolver(self, other) & - bind(C, name="_wrap_assign_NOXSolver") - use, intrinsic :: ISO_C_BINDING - import :: SwigClassWrapper - type(SwigClassWrapper), intent(inout) :: self - type(SwigClassWrapper), intent(in) :: other - end subroutine end interface @@ -550,17 +561,28 @@ function new_TrilinosSolver() & result(self) use, intrinsic :: ISO_C_BINDING type(TrilinosSolver) :: self - type(SwigClassWrapper) :: fresult fresult = swigc_new_TrilinosSolver() self%swigdata = fresult end function -subroutine swigf_TrilinosSolver_init__SWIG_0(self) +subroutine swigf_TrilinosSolver_op_assign__(self, other) use, intrinsic :: ISO_C_BINDING class(TrilinosSolver), intent(inout) :: self +type(TrilinosSolver), intent(in) :: other +type(SwigClassWrapper) :: farg1 +type(SwigClassWrapper) :: farg2 + +farg1 = self%swigdata +farg2 = other%swigdata +call swigc_TrilinosSolver_op_assign__(farg1, farg2) +self%swigdata = farg1 +end subroutine +subroutine swigf_TrilinosSolver_init__SWIG_0(self) +use, intrinsic :: ISO_C_BINDING +class(TrilinosSolver), intent(in) :: self type(SwigClassWrapper) :: farg1 farg1 = self%swigdata @@ -569,10 +591,8 @@ subroutine swigf_TrilinosSolver_init__SWIG_0(self) subroutine swigf_TrilinosSolver_init__SWIG_1(self, comm) use, intrinsic :: ISO_C_BINDING -class(TrilinosSolver), intent(inout) :: self - +class(TrilinosSolver), intent(in) :: self class(TeuchosComm), intent(in) :: comm - type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 @@ -583,10 +603,8 @@ subroutine swigf_TrilinosSolver_init__SWIG_1(self, comm) subroutine swigf_TrilinosSolver_setup_matrix(self, a) use, intrinsic :: ISO_C_BINDING -class(TrilinosSolver), intent(inout) :: self - +class(TrilinosSolver), intent(in) :: self class(TpetraCrsMatrix), intent(in) :: a - type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 @@ -597,10 +615,8 @@ subroutine swigf_TrilinosSolver_setup_matrix(self, a) subroutine swigf_TrilinosSolver_setup_operator(self, a) use, intrinsic :: ISO_C_BINDING -class(TrilinosSolver), intent(inout) :: self - +class(TrilinosSolver), intent(in) :: self class(TpetraOperator), intent(in) :: a - type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 @@ -611,10 +627,8 @@ subroutine swigf_TrilinosSolver_setup_operator(self, a) subroutine swigf_TrilinosSolver_setup_solver(self, paramlist) use, intrinsic :: ISO_C_BINDING -class(TrilinosSolver), intent(inout) :: self - +class(TrilinosSolver), intent(in) :: self class(ParameterList), intent(in) :: paramlist - type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 @@ -626,11 +640,8 @@ subroutine swigf_TrilinosSolver_setup_solver(self, paramlist) subroutine swigf_TrilinosSolver_solve(self, rhs, lhs) use, intrinsic :: ISO_C_BINDING class(TrilinosSolver), intent(in) :: self - class(TpetraMultiVector), intent(in) :: rhs - -class(TpetraMultiVector), intent(inout) :: lhs - +class(TpetraMultiVector), intent(in) :: lhs type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 type(SwigClassWrapper) :: farg3 @@ -643,8 +654,7 @@ subroutine swigf_TrilinosSolver_solve(self, rhs, lhs) subroutine swigf_TrilinosSolver_finalize(self) use, intrinsic :: ISO_C_BINDING -class(TrilinosSolver), intent(inout) :: self - +class(TrilinosSolver), intent(in) :: self type(SwigClassWrapper) :: farg1 farg1 = self%swigdata @@ -654,7 +664,6 @@ subroutine swigf_TrilinosSolver_finalize(self) subroutine delete_TrilinosSolver(self) use, intrinsic :: ISO_C_BINDING class(TrilinosSolver), intent(inout) :: self - type(SwigClassWrapper) :: farg1 farg1 = self%swigdata @@ -665,27 +674,32 @@ subroutine delete_TrilinosSolver(self) self%swigdata%mem = SWIG_NULL end subroutine - subroutine swigf_assignment_TrilinosSolver(self, other) - use, intrinsic :: ISO_C_BINDING - class(TrilinosSolver), intent(inout) :: self - type(TrilinosSolver), intent(in) :: other - call swigc_assignment_TrilinosSolver(self%swigdata, other%swigdata) - end subroutine function new_TrilinosEigenSolver() & result(self) use, intrinsic :: ISO_C_BINDING type(TrilinosEigenSolver) :: self - type(SwigClassWrapper) :: fresult fresult = swigc_new_TrilinosEigenSolver() self%swigdata = fresult end function -subroutine swigf_TrilinosEigenSolver_init__SWIG_0(self) +subroutine swigf_TrilinosEigenSolver_op_assign__(self, other) use, intrinsic :: ISO_C_BINDING class(TrilinosEigenSolver), intent(inout) :: self +type(TrilinosEigenSolver), intent(in) :: other +type(SwigClassWrapper) :: farg1 +type(SwigClassWrapper) :: farg2 + +farg1 = self%swigdata +farg2 = other%swigdata +call swigc_TrilinosEigenSolver_op_assign__(farg1, farg2) +self%swigdata = farg1 +end subroutine +subroutine swigf_TrilinosEigenSolver_init__SWIG_0(self) +use, intrinsic :: ISO_C_BINDING +class(TrilinosEigenSolver), intent(in) :: self type(SwigClassWrapper) :: farg1 farg1 = self%swigdata @@ -694,10 +708,8 @@ subroutine swigf_TrilinosEigenSolver_init__SWIG_0(self) subroutine swigf_TrilinosEigenSolver_init__SWIG_1(self, comm) use, intrinsic :: ISO_C_BINDING -class(TrilinosEigenSolver), intent(inout) :: self - +class(TrilinosEigenSolver), intent(in) :: self class(TeuchosComm), intent(in) :: comm - type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 @@ -708,10 +720,8 @@ subroutine swigf_TrilinosEigenSolver_init__SWIG_1(self, comm) subroutine swigf_TrilinosEigenSolver_setup_matrix(self, a) use, intrinsic :: ISO_C_BINDING -class(TrilinosEigenSolver), intent(inout) :: self - +class(TrilinosEigenSolver), intent(in) :: self class(TpetraCrsMatrix), intent(in) :: a - type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 @@ -722,10 +732,8 @@ subroutine swigf_TrilinosEigenSolver_setup_matrix(self, a) subroutine swigf_TrilinosEigenSolver_setup_matrix_rhs(self, m) use, intrinsic :: ISO_C_BINDING -class(TrilinosEigenSolver), intent(inout) :: self - +class(TrilinosEigenSolver), intent(in) :: self class(TpetraCrsMatrix), intent(in) :: m - type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 @@ -736,10 +744,8 @@ subroutine swigf_TrilinosEigenSolver_setup_matrix_rhs(self, m) subroutine swigf_TrilinosEigenSolver_setup_operator(self, a) use, intrinsic :: ISO_C_BINDING -class(TrilinosEigenSolver), intent(inout) :: self - +class(TrilinosEigenSolver), intent(in) :: self class(TpetraOperator), intent(in) :: a - type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 @@ -750,10 +756,8 @@ subroutine swigf_TrilinosEigenSolver_setup_operator(self, a) subroutine swigf_TrilinosEigenSolver_setup_operator_rhs(self, m) use, intrinsic :: ISO_C_BINDING -class(TrilinosEigenSolver), intent(inout) :: self - +class(TrilinosEigenSolver), intent(in) :: self class(TpetraOperator), intent(in) :: m - type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 @@ -764,10 +768,8 @@ subroutine swigf_TrilinosEigenSolver_setup_operator_rhs(self, m) subroutine swigf_TrilinosEigenSolver_setup_solver(self, paramlist) use, intrinsic :: ISO_C_BINDING -class(TrilinosEigenSolver), intent(inout) :: self - +class(TrilinosEigenSolver), intent(in) :: self class(ParameterList), intent(in) :: paramlist - type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 @@ -781,14 +783,11 @@ function swigf_TrilinosEigenSolver_solve(self, eigenvalues, eigenvectors, eigeni use, intrinsic :: ISO_C_BINDING integer :: swig_result class(TrilinosEigenSolver), intent(in) :: self - real(C_DOUBLE), dimension(:), target :: eigenvalues real(C_DOUBLE), pointer :: farg2_view -class(TpetraMultiVector), intent(inout) :: eigenvectors - +class(TpetraMultiVector), intent(in) :: eigenvectors integer(C_INT), dimension(:), target :: eigenindex integer(C_INT), pointer :: farg4_view - integer(C_INT) :: fresult type(SwigClassWrapper) :: farg1 type(SwigArrayWrapper) :: farg2 @@ -819,8 +818,7 @@ function swigf_TrilinosEigenSolver_solve(self, eigenvalues, eigenvectors, eigeni subroutine swigf_TrilinosEigenSolver_finalize(self) use, intrinsic :: ISO_C_BINDING -class(TrilinosEigenSolver), intent(inout) :: self - +class(TrilinosEigenSolver), intent(in) :: self type(SwigClassWrapper) :: farg1 farg1 = self%swigdata @@ -830,7 +828,6 @@ subroutine swigf_TrilinosEigenSolver_finalize(self) subroutine delete_TrilinosEigenSolver(self) use, intrinsic :: ISO_C_BINDING class(TrilinosEigenSolver), intent(inout) :: self - type(SwigClassWrapper) :: farg1 farg1 = self%swigdata @@ -841,20 +838,11 @@ subroutine delete_TrilinosEigenSolver(self) self%swigdata%mem = SWIG_NULL end subroutine - subroutine swigf_assignment_TrilinosEigenSolver(self, other) - use, intrinsic :: ISO_C_BINDING - class(TrilinosEigenSolver), intent(inout) :: self - type(TrilinosEigenSolver), intent(in) :: other - call swigc_assignment_TrilinosEigenSolver(self%swigdata, other%swigdata) - end subroutine subroutine swigf_ForTrilinosModelEvaluator_evaluate_residual(self, x, f) use, intrinsic :: ISO_C_BINDING class(ForTrilinosModelEvaluator), intent(in) :: self - class(TpetraMultiVector), intent(in) :: x - -class(TpetraMultiVector), intent(inout) :: f - +class(TpetraMultiVector), intent(in) :: f type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 type(SwigClassWrapper) :: farg3 @@ -868,11 +856,8 @@ subroutine swigf_ForTrilinosModelEvaluator_evaluate_residual(self, x, f) subroutine swigf_ForTrilinosModelEvaluator_evaluate_jacobian(self, x, j) use, intrinsic :: ISO_C_BINDING class(ForTrilinosModelEvaluator), intent(in) :: self - class(TpetraMultiVector), intent(in) :: x - -class(TpetraOperator), intent(inout) :: j - +class(TpetraOperator), intent(in) :: j type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 type(SwigClassWrapper) :: farg3 @@ -886,11 +871,8 @@ subroutine swigf_ForTrilinosModelEvaluator_evaluate_jacobian(self, x, j) subroutine swigf_ForTrilinosModelEvaluator_evaluate_preconditioner(self, x, m) use, intrinsic :: ISO_C_BINDING class(ForTrilinosModelEvaluator), intent(in) :: self - class(TpetraMultiVector), intent(in) :: x - -class(TpetraOperator), intent(inout) :: m - +class(TpetraOperator), intent(in) :: m type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 type(SwigClassWrapper) :: farg3 @@ -906,7 +888,6 @@ function swigf_ForTrilinosModelEvaluator_get_x_map(self) & use, intrinsic :: ISO_C_BINDING type(TpetraMap) :: swig_result class(ForTrilinosModelEvaluator), intent(in) :: self - type(SwigClassWrapper) :: fresult type(SwigClassWrapper) :: farg1 @@ -920,7 +901,6 @@ function swigf_ForTrilinosModelEvaluator_get_f_map(self) & use, intrinsic :: ISO_C_BINDING type(TpetraMap) :: swig_result class(ForTrilinosModelEvaluator), intent(in) :: self - type(SwigClassWrapper) :: fresult type(SwigClassWrapper) :: farg1 @@ -934,7 +914,6 @@ function swigf_ForTrilinosModelEvaluator_create_operator(self) & use, intrinsic :: ISO_C_BINDING type(TpetraOperator) :: swig_result class(ForTrilinosModelEvaluator), intent(in) :: self - type(SwigClassWrapper) :: fresult type(SwigClassWrapper) :: farg1 @@ -945,10 +924,8 @@ function swigf_ForTrilinosModelEvaluator_create_operator(self) & subroutine swigf_ForTrilinosModelEvaluator_setup(self, plist) use, intrinsic :: ISO_C_BINDING -class(ForTrilinosModelEvaluator), intent(inout) :: self - -class(ParameterList), intent(inout) :: plist - +class(ForTrilinosModelEvaluator), intent(in) :: self +class(ParameterList), intent(in) :: plist type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 @@ -960,7 +937,6 @@ subroutine swigf_ForTrilinosModelEvaluator_setup(self, plist) subroutine delete_ForTrilinosModelEvaluator(self) use, intrinsic :: ISO_C_BINDING class(ForTrilinosModelEvaluator), intent(inout) :: self - type(SwigClassWrapper) :: farg1 farg1 = self%swigdata @@ -971,18 +947,24 @@ subroutine delete_ForTrilinosModelEvaluator(self) self%swigdata%mem = SWIG_NULL end subroutine - subroutine swigf_assignment_ForTrilinosModelEvaluator(self, other) - use, intrinsic :: ISO_C_BINDING - class(ForTrilinosModelEvaluator), intent(inout) :: self - type(ForTrilinosModelEvaluator), intent(in) :: other - call swigc_assignment_ForTrilinosModelEvaluator(self%swigdata, other%swigdata) - end subroutine +subroutine swigf_ForTrilinosModelEvaluator_op_assign__(self, other) +use, intrinsic :: ISO_C_BINDING +class(ForTrilinosModelEvaluator), intent(inout) :: self +type(SWIGTYPE_ForTrilinos__ModelEvaluatorT_SC_LO_GO_NO_t), intent(in) :: other +type(SwigClassWrapper) :: farg1 +type(SwigClassWrapper) :: farg2 + +farg1 = self%swigdata +farg2 = other%swigdata +call swigc_ForTrilinosModelEvaluator_op_assign__(farg1, farg2) +self%swigdata = farg1 +end subroutine + function swigf_ForModelEvaluator_fhandle(self) & result(swig_result) use, intrinsic :: ISO_C_BINDING type(C_PTR) :: swig_result class(ForModelEvaluator), intent(in) :: self - type(C_PTR) :: fresult type(SwigClassWrapper) :: farg1 @@ -993,10 +975,8 @@ function swigf_ForModelEvaluator_fhandle(self) & subroutine swigf_ForModelEvaluator_init(self, fh) use, intrinsic :: ISO_C_BINDING -class(ForModelEvaluator), intent(inout) :: self - +class(ForModelEvaluator), intent(in) :: self type(C_PTR) :: fh - type(SwigClassWrapper) :: farg1 type(C_PTR) :: farg2 @@ -1007,10 +987,8 @@ subroutine swigf_ForModelEvaluator_init(self, fh) subroutine swigf_ForModelEvaluator_setup(self, plist) use, intrinsic :: ISO_C_BINDING -class(ForModelEvaluator), intent(inout) :: self - -class(ParameterList), intent(inout) :: plist - +class(ForModelEvaluator), intent(in) :: self +class(ParameterList), intent(in) :: plist type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 @@ -1022,11 +1000,8 @@ subroutine swigf_ForModelEvaluator_setup(self, plist) subroutine swigf_ForModelEvaluator_evaluate_residual(self, x, f) use, intrinsic :: ISO_C_BINDING class(ForModelEvaluator), intent(in) :: self - class(TpetraMultiVector), intent(in) :: x - -class(TpetraMultiVector), intent(inout) :: f - +class(TpetraMultiVector), intent(in) :: f type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 type(SwigClassWrapper) :: farg3 @@ -1040,11 +1015,8 @@ subroutine swigf_ForModelEvaluator_evaluate_residual(self, x, f) subroutine swigf_ForModelEvaluator_evaluate_jacobian(self, x, j) use, intrinsic :: ISO_C_BINDING class(ForModelEvaluator), intent(in) :: self - class(TpetraMultiVector), intent(in) :: x - -class(TpetraOperator), intent(inout) :: j - +class(TpetraOperator), intent(in) :: j type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 type(SwigClassWrapper) :: farg3 @@ -1058,11 +1030,8 @@ subroutine swigf_ForModelEvaluator_evaluate_jacobian(self, x, j) subroutine swigf_ForModelEvaluator_evaluate_preconditioner(self, x, m) use, intrinsic :: ISO_C_BINDING class(ForModelEvaluator), intent(in) :: self - class(TpetraMultiVector), intent(in) :: x - -class(TpetraOperator), intent(inout) :: m - +class(TpetraOperator), intent(in) :: m type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 type(SwigClassWrapper) :: farg3 @@ -1078,7 +1047,6 @@ function swigf_ForModelEvaluator_get_x_map(self) & use, intrinsic :: ISO_C_BINDING type(TpetraMap) :: swig_result class(ForModelEvaluator), intent(in) :: self - type(SwigClassWrapper) :: fresult type(SwigClassWrapper) :: farg1 @@ -1092,7 +1060,6 @@ function swigf_ForModelEvaluator_get_f_map(self) & use, intrinsic :: ISO_C_BINDING type(TpetraMap) :: swig_result class(ForModelEvaluator), intent(in) :: self - type(SwigClassWrapper) :: fresult type(SwigClassWrapper) :: farg1 @@ -1106,7 +1073,6 @@ function swigf_ForModelEvaluator_create_operator(self) & use, intrinsic :: ISO_C_BINDING type(TpetraOperator) :: swig_result class(ForModelEvaluator), intent(in) :: self - type(SwigClassWrapper) :: fresult type(SwigClassWrapper) :: farg1 @@ -1119,7 +1085,6 @@ function new_ForModelEvaluator() & result(self) use, intrinsic :: ISO_C_BINDING type(ForModelEvaluator) :: self - type(SwigClassWrapper) :: fresult fresult = swigc_new_ForModelEvaluator() @@ -1129,7 +1094,6 @@ function new_ForModelEvaluator() & subroutine delete_ForModelEvaluator(self) use, intrinsic :: ISO_C_BINDING class(ForModelEvaluator), intent(inout) :: self - type(SwigClassWrapper) :: farg1 @@ -1148,12 +1112,19 @@ subroutine delete_ForModelEvaluator(self) deallocate(handle) end subroutine - subroutine swigf_assignment_ForModelEvaluator(self, other) - use, intrinsic :: ISO_C_BINDING - class(ForModelEvaluator), intent(inout) :: self - type(ForModelEvaluator), intent(in) :: other - call swigc_assignment_ForModelEvaluator(self%swigdata, other%swigdata) - end subroutine +subroutine swigf_ForModelEvaluator_op_assign__(self, other) +use, intrinsic :: ISO_C_BINDING +class(ForModelEvaluator), intent(inout) :: self +type(ForModelEvaluator), intent(in) :: other +type(SwigClassWrapper) :: farg1 +type(SwigClassWrapper) :: farg2 + +farg1 = self%swigdata +farg2 = other%swigdata +call swigc_ForModelEvaluator_op_assign__(farg1, farg2) +self%swigdata = farg1 +end subroutine + ! Convert a ISO-C class pointer struct into a user Fortran native pointer subroutine c_f_pointer_ForModelEvaluator(clswrap, fptr) @@ -1298,7 +1269,7 @@ function swigd_ForModelEvaluator_create_operator(fself) & type(SwigClassWrapper) :: fresult class(ForModelEvaluator), pointer :: self - type(ForTpetraOperator) :: result + type(TpetraOperator) :: result ! Get pointer to Fortran object from class Handle call c_f_pointer_ForModelEvaluator(fself, self) @@ -1324,7 +1295,6 @@ function new_NOXSolver(model) & use, intrinsic :: ISO_C_BINDING type(NOXSolver) :: self class(ForTrilinosModelEvaluator), intent(in) :: model - type(SwigClassWrapper) :: fresult type(SwigClassWrapper) :: farg1 @@ -1335,10 +1305,8 @@ function new_NOXSolver(model) & subroutine swigf_NOXSolver_setup(self, plist) use, intrinsic :: ISO_C_BINDING -class(NOXSolver), intent(inout) :: self - -class(ParameterList), intent(inout) :: plist - +class(NOXSolver), intent(in) :: self +class(ParameterList), intent(in) :: plist type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 @@ -1351,8 +1319,7 @@ function swigf_NOXSolver_solve(self) & result(swig_result) use, intrinsic :: ISO_C_BINDING integer(SWIGTYPE_NOX__StatusTest__StatusType) :: swig_result -class(NOXSolver), intent(inout) :: self - +class(NOXSolver), intent(in) :: self integer(C_INT) :: fresult type(SwigClassWrapper) :: farg1 @@ -1364,7 +1331,6 @@ function swigf_NOXSolver_solve(self) & subroutine delete_NOXSolver(self) use, intrinsic :: ISO_C_BINDING class(NOXSolver), intent(inout) :: self - type(SwigClassWrapper) :: farg1 farg1 = self%swigdata @@ -1375,11 +1341,18 @@ subroutine delete_NOXSolver(self) self%swigdata%mem = SWIG_NULL end subroutine - subroutine swigf_assignment_NOXSolver(self, other) - use, intrinsic :: ISO_C_BINDING - class(NOXSolver), intent(inout) :: self - type(NOXSolver), intent(in) :: other - call swigc_assignment_NOXSolver(self%swigdata, other%swigdata) - end subroutine +subroutine swigf_NOXSolver_op_assign__(self, other) +use, intrinsic :: ISO_C_BINDING +class(NOXSolver), intent(inout) :: self +type(SWIGTYPE_ForTrilinos__NOXSolverT_SC_LO_GO_NO_t), intent(in) :: other +type(SwigClassWrapper) :: farg1 +type(SwigClassWrapper) :: farg2 + +farg1 = self%swigdata +farg2 = other%swigdata +call swigc_NOXSolver_op_assign__(farg1, farg2) +self%swigdata = farg1 +end subroutine + end module diff --git a/src/interface/src/swig/fortrilinosFORTRAN_wrap.cxx b/src/interface/src/swig/fortrilinosFORTRAN_wrap.cxx index dbd90f0a..824dcc34 100644 --- a/src/interface/src/swig/fortrilinosFORTRAN_wrap.cxx +++ b/src/interface/src/swig/fortrilinosFORTRAN_wrap.cxx @@ -205,6 +205,25 @@ void SWIG_store_exception(const char* decl, int errcode, const char *msg); SWIG_store_exception(DECL, CODE, MSG); RETURNNULL; +namespace swig { + +enum AssignmentFlags { + IS_DESTR = 0x01, + IS_COPY_CONSTR = 0x02, + IS_COPY_ASSIGN = 0x04, + IS_MOVE_CONSTR = 0x08, + IS_MOVE_ASSIGN = 0x10 +}; + +template +struct assignment_flags; +} + + +#define SWIG_assign(LEFTTYPE, LEFT, RIGHTTYPE, RIGHT, FLAGS) \ + SWIG_assign_impl::value >(LEFT, RIGHT); + + #define SWIG_check_mutable(SWIG_CLASS_WRAPPER, TYPENAME, FNAME, FUNCNAME, RETURNNULL) \ if ((SWIG_CLASS_WRAPPER).mem == SWIG_CREF) { \ SWIG_exception_impl(FUNCNAME, SWIG_TypeError, \ @@ -227,23 +246,12 @@ void SWIG_store_exception(const char* decl, int errcode, const char *msg); SWIG_check_mutable(SWIG_CLASS_WRAPPER, TYPENAME, FNAME, FUNCNAME, RETURNNULL); -namespace swig { - -enum AssignmentFlags { - IS_DESTR = 0x01, - IS_COPY_CONSTR = 0x02, - IS_COPY_ASSIGN = 0x04, - IS_MOVE_CONSTR = 0x08, - IS_MOVE_ASSIGN = 0x10 -}; - -template -struct assignment_flags; -} - - -#define SWIG_assign(LEFTTYPE, LEFT, RIGHTTYPE, RIGHT, FLAGS) \ - SWIG_assign_impl::value >(LEFT, RIGHT); +#define SWIG_check_sp_nonnull(INPUT, TYPENAME, FNAME, FUNCNAME, RETURNNULL) \ + if (!(INPUT)) { \ + SWIG_exception_impl(FUNCNAME, SWIG_TypeError, \ + "Cannot pass null " TYPENAME " (class " FNAME ") " \ + "as a reference", RETURNNULL); \ + } #include @@ -437,7 +445,7 @@ struct AssignmentTraits { template -SWIGINTERN void SWIG_assign_impl(SwigClassWrapper* self, SwigClassWrapper* other) { +SWIGINTERN void SWIG_assign_impl(SwigClassWrapper* self, const SwigClassWrapper* other) { typedef swig::AssignmentTraits Traits_t; T1* pself = static_cast(self->cptr); T2* pother = static_cast(other->cptr); @@ -450,9 +458,7 @@ SWIGINTERN void SWIG_assign_impl(SwigClassWrapper* self, SwigClassWrapper* other break; case SWIG_MOVE: /* capture pointer from RHS */ self->cptr = other->cptr; - other->cptr = NULL; self->mem = SWIG_OWN; - other->mem = SWIG_NULL; break; case SWIG_OWN: /* copy from RHS */ self->cptr = Traits_t::copy_construct(pother); @@ -478,8 +484,6 @@ SWIGINTERN void SWIG_assign_impl(SwigClassWrapper* self, SwigClassWrapper* other /* Move RHS into LHS; delete RHS */ Traits_t::move_assign(pself, pother); Traits_t::destruct(pother); - other->cptr = NULL; - other->mem = SWIG_NULL; break; case SWIG_OWN: case SWIG_REF: @@ -507,8 +511,6 @@ SWIGINTERN void SWIG_assign_impl(SwigClassWrapper* self, SwigClassWrapper* other * same. */ Traits_t::move_assign(pself, pother); Traits_t::destruct(pother); - other->cptr = NULL; - other->mem = SWIG_NULL; break; case SWIG_OWN: case SWIG_REF: @@ -769,6 +771,39 @@ SWIGEXPORT SwigClassWrapper _wrap_new_TrilinosSolver() { } +SWIGEXPORT void _wrap_TrilinosSolver_op_assign__(SwigClassWrapper *farg1, SwigClassWrapper const *farg2) { + ForTrilinos::TrilinosSolver *arg1 = (ForTrilinos::TrilinosSolver *) 0 ; + ForTrilinos::TrilinosSolver *arg2 = 0 ; + + (void)sizeof(arg1); + (void)sizeof(arg2); + { + // Make sure no unhandled exceptions exist before performing a new action + SWIG_check_unhandled_exception_impl("ForTrilinos::TrilinosSolver::operator =(ForTrilinos::TrilinosSolver const &)");; + try + { + // Attempt the wrapped function call + typedef ForTrilinos::TrilinosSolver swig_lhs_classtype; + SWIG_assign(swig_lhs_classtype, farg1, swig_lhs_classtype, farg2, 0 | swig::IS_DESTR | swig::IS_COPY_CONSTR); + } + catch (const std::range_error& e) + { + // Store a C++ exception + SWIG_exception_impl("ForTrilinos::TrilinosSolver::operator =(ForTrilinos::TrilinosSolver const &)", SWIG_IndexError, e.what(), return ); + } + catch (const std::exception& e) + { + // Store a C++ exception + SWIG_exception_impl("ForTrilinos::TrilinosSolver::operator =(ForTrilinos::TrilinosSolver const &)", SWIG_RuntimeError, e.what(), return ); + } + catch (...) + { + SWIG_exception_impl("ForTrilinos::TrilinosSolver::operator =(ForTrilinos::TrilinosSolver const &)", SWIG_UnknownError, "An unknown exception occurred", return ); + } + } +} + + SWIGEXPORT void _wrap_TrilinosSolver_init__SWIG_0(SwigClassWrapper const *farg1) { ForTrilinos::TrilinosSolver *arg1 = (ForTrilinos::TrilinosSolver *) 0 ; @@ -797,7 +832,6 @@ SWIGEXPORT void _wrap_TrilinosSolver_init__SWIG_0(SwigClassWrapper const *farg1) SWIG_exception_impl("ForTrilinos::TrilinosSolver::init()", SWIG_UnknownError, "An unknown exception occurred", return ); } } - } @@ -832,7 +866,6 @@ SWIGEXPORT void _wrap_TrilinosSolver_init__SWIG_1(SwigClassWrapper const *farg1, SWIG_exception_impl("ForTrilinos::TrilinosSolver::init(Teuchos::RCP< Teuchos::Comm< int > const > const &)", SWIG_UnknownError, "An unknown exception occurred", return ); } } - } @@ -867,7 +900,6 @@ SWIGEXPORT void _wrap_TrilinosSolver_setup_matrix(SwigClassWrapper const *farg1, SWIG_exception_impl("ForTrilinos::TrilinosSolver::setup_matrix(Teuchos::RCP< ForTrilinos::TrilinosSolver::Matrix > const &)", SWIG_UnknownError, "An unknown exception occurred", return ); } } - } @@ -902,7 +934,6 @@ SWIGEXPORT void _wrap_TrilinosSolver_setup_operator(SwigClassWrapper const *farg SWIG_exception_impl("ForTrilinos::TrilinosSolver::setup_operator(Teuchos::RCP< ForTrilinos::TrilinosSolver::Operator > const &)", SWIG_UnknownError, "An unknown exception occurred", return ); } } - } @@ -937,7 +968,6 @@ SWIGEXPORT void _wrap_TrilinosSolver_setup_solver(SwigClassWrapper const *farg1, SWIG_exception_impl("ForTrilinos::TrilinosSolver::setup_solver(Teuchos::RCP< Teuchos::ParameterList > const &)", SWIG_UnknownError, "An unknown exception occurred", return ); } } - } @@ -975,7 +1005,6 @@ SWIGEXPORT void _wrap_TrilinosSolver_solve(SwigClassWrapper const *farg1, SwigCl SWIG_exception_impl("ForTrilinos::TrilinosSolver::solve(Teuchos::RCP< ForTrilinos::TrilinosSolver::MultiVector const > const &,Teuchos::RCP< ForTrilinos::TrilinosSolver::MultiVector > &) const", SWIG_UnknownError, "An unknown exception occurred", return ); } } - } @@ -1007,15 +1036,13 @@ SWIGEXPORT void _wrap_TrilinosSolver_finalize(SwigClassWrapper const *farg1) { SWIG_exception_impl("ForTrilinos::TrilinosSolver::finalize()", SWIG_UnknownError, "An unknown exception occurred", return ); } } - } -SWIGEXPORT void _wrap_delete_TrilinosSolver(SwigClassWrapper const *farg1) { +SWIGEXPORT void _wrap_delete_TrilinosSolver(SwigClassWrapper *farg1) { ForTrilinos::TrilinosSolver *arg1 = (ForTrilinos::TrilinosSolver *) 0 ; - SWIG_check_mutable_nonnull(*farg1, "ForTrilinos::TrilinosSolver *", "TrilinosSolver", "ForTrilinos::TrilinosSolver::~TrilinosSolver()", return ); - arg1 = static_cast< ForTrilinos::TrilinosSolver * >(farg1->cptr); + (void)sizeof(farg1); { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("ForTrilinos::TrilinosSolver::~TrilinosSolver()");; @@ -1039,15 +1066,6 @@ SWIGEXPORT void _wrap_delete_TrilinosSolver(SwigClassWrapper const *farg1) { SWIG_exception_impl("ForTrilinos::TrilinosSolver::~TrilinosSolver()", SWIG_UnknownError, "An unknown exception occurred", return ); } } - -} - - -SWIGEXPORT void _wrap_assign_TrilinosSolver(SwigClassWrapper * self, SwigClassWrapper const * other) { - typedef ForTrilinos::TrilinosSolver swig_lhs_classtype; - SWIG_assign(swig_lhs_classtype, self, - swig_lhs_classtype, const_cast(other), - 0 | swig::IS_DESTR | swig::IS_COPY_CONSTR); } @@ -1084,6 +1102,39 @@ SWIGEXPORT SwigClassWrapper _wrap_new_TrilinosEigenSolver() { } +SWIGEXPORT void _wrap_TrilinosEigenSolver_op_assign__(SwigClassWrapper *farg1, SwigClassWrapper const *farg2) { + ForTrilinos::TrilinosEigenSolver *arg1 = (ForTrilinos::TrilinosEigenSolver *) 0 ; + ForTrilinos::TrilinosEigenSolver *arg2 = 0 ; + + (void)sizeof(arg1); + (void)sizeof(arg2); + { + // Make sure no unhandled exceptions exist before performing a new action + SWIG_check_unhandled_exception_impl("ForTrilinos::TrilinosEigenSolver::operator =(ForTrilinos::TrilinosEigenSolver const &)");; + try + { + // Attempt the wrapped function call + typedef ForTrilinos::TrilinosEigenSolver swig_lhs_classtype; + SWIG_assign(swig_lhs_classtype, farg1, swig_lhs_classtype, farg2, 0 | swig::IS_DESTR | swig::IS_COPY_CONSTR); + } + catch (const std::range_error& e) + { + // Store a C++ exception + SWIG_exception_impl("ForTrilinos::TrilinosEigenSolver::operator =(ForTrilinos::TrilinosEigenSolver const &)", SWIG_IndexError, e.what(), return ); + } + catch (const std::exception& e) + { + // Store a C++ exception + SWIG_exception_impl("ForTrilinos::TrilinosEigenSolver::operator =(ForTrilinos::TrilinosEigenSolver const &)", SWIG_RuntimeError, e.what(), return ); + } + catch (...) + { + SWIG_exception_impl("ForTrilinos::TrilinosEigenSolver::operator =(ForTrilinos::TrilinosEigenSolver const &)", SWIG_UnknownError, "An unknown exception occurred", return ); + } + } +} + + SWIGEXPORT void _wrap_TrilinosEigenSolver_init__SWIG_0(SwigClassWrapper const *farg1) { ForTrilinos::TrilinosEigenSolver *arg1 = (ForTrilinos::TrilinosEigenSolver *) 0 ; @@ -1112,7 +1163,6 @@ SWIGEXPORT void _wrap_TrilinosEigenSolver_init__SWIG_0(SwigClassWrapper const *f SWIG_exception_impl("ForTrilinos::TrilinosEigenSolver::init()", SWIG_UnknownError, "An unknown exception occurred", return ); } } - } @@ -1147,7 +1197,6 @@ SWIGEXPORT void _wrap_TrilinosEigenSolver_init__SWIG_1(SwigClassWrapper const *f SWIG_exception_impl("ForTrilinos::TrilinosEigenSolver::init(Teuchos::RCP< Teuchos::Comm< int > const > const &)", SWIG_UnknownError, "An unknown exception occurred", return ); } } - } @@ -1182,7 +1231,6 @@ SWIGEXPORT void _wrap_TrilinosEigenSolver_setup_matrix(SwigClassWrapper const *f SWIG_exception_impl("ForTrilinos::TrilinosEigenSolver::setup_matrix(Teuchos::RCP< ForTrilinos::TrilinosEigenSolver::Matrix > const &)", SWIG_UnknownError, "An unknown exception occurred", return ); } } - } @@ -1217,7 +1265,6 @@ SWIGEXPORT void _wrap_TrilinosEigenSolver_setup_matrix_rhs(SwigClassWrapper cons SWIG_exception_impl("ForTrilinos::TrilinosEigenSolver::setup_matrix_rhs(Teuchos::RCP< ForTrilinos::TrilinosEigenSolver::Matrix > const &)", SWIG_UnknownError, "An unknown exception occurred", return ); } } - } @@ -1252,7 +1299,6 @@ SWIGEXPORT void _wrap_TrilinosEigenSolver_setup_operator(SwigClassWrapper const SWIG_exception_impl("ForTrilinos::TrilinosEigenSolver::setup_operator(Teuchos::RCP< ForTrilinos::TrilinosEigenSolver::Operator > const &)", SWIG_UnknownError, "An unknown exception occurred", return ); } } - } @@ -1287,7 +1333,6 @@ SWIGEXPORT void _wrap_TrilinosEigenSolver_setup_operator_rhs(SwigClassWrapper co SWIG_exception_impl("ForTrilinos::TrilinosEigenSolver::setup_operator_rhs(Teuchos::RCP< ForTrilinos::TrilinosEigenSolver::Operator > const &)", SWIG_UnknownError, "An unknown exception occurred", return ); } } - } @@ -1322,7 +1367,6 @@ SWIGEXPORT void _wrap_TrilinosEigenSolver_setup_solver(SwigClassWrapper const *f SWIG_exception_impl("ForTrilinos::TrilinosEigenSolver::setup_solver(Teuchos::RCP< Teuchos::ParameterList > const &)", SWIG_UnknownError, "An unknown exception occurred", return ); } } - } @@ -1396,15 +1440,13 @@ SWIGEXPORT void _wrap_TrilinosEigenSolver_finalize(SwigClassWrapper const *farg1 SWIG_exception_impl("ForTrilinos::TrilinosEigenSolver::finalize()", SWIG_UnknownError, "An unknown exception occurred", return ); } } - } -SWIGEXPORT void _wrap_delete_TrilinosEigenSolver(SwigClassWrapper const *farg1) { +SWIGEXPORT void _wrap_delete_TrilinosEigenSolver(SwigClassWrapper *farg1) { ForTrilinos::TrilinosEigenSolver *arg1 = (ForTrilinos::TrilinosEigenSolver *) 0 ; - SWIG_check_mutable_nonnull(*farg1, "ForTrilinos::TrilinosEigenSolver *", "TrilinosEigenSolver", "ForTrilinos::TrilinosEigenSolver::~TrilinosEigenSolver()", return ); - arg1 = static_cast< ForTrilinos::TrilinosEigenSolver * >(farg1->cptr); + (void)sizeof(farg1); { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("ForTrilinos::TrilinosEigenSolver::~TrilinosEigenSolver()");; @@ -1428,15 +1470,6 @@ SWIGEXPORT void _wrap_delete_TrilinosEigenSolver(SwigClassWrapper const *farg1) SWIG_exception_impl("ForTrilinos::TrilinosEigenSolver::~TrilinosEigenSolver()", SWIG_UnknownError, "An unknown exception occurred", return ); } } - -} - - -SWIGEXPORT void _wrap_assign_TrilinosEigenSolver(SwigClassWrapper * self, SwigClassWrapper const * other) { - typedef ForTrilinos::TrilinosEigenSolver swig_lhs_classtype; - SWIG_assign(swig_lhs_classtype, self, - swig_lhs_classtype, const_cast(other), - 0 | swig::IS_DESTR | swig::IS_COPY_CONSTR); } @@ -1475,7 +1508,6 @@ SWIGEXPORT void _wrap_ForTrilinosModelEvaluator_evaluate_residual(SwigClassWrapp SWIG_exception_impl("ForTrilinos::ModelEvaluator< SC,LO,GO,NO >::evaluate_residual(Teuchos::RCP< ForTrilinos::ModelEvaluator< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::MultiVector const > const &,Teuchos::RCP< ForTrilinos::ModelEvaluator< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::MultiVector > &) const", SWIG_UnknownError, "An unknown exception occurred", return ); } } - } @@ -1514,7 +1546,6 @@ SWIGEXPORT void _wrap_ForTrilinosModelEvaluator_evaluate_jacobian(SwigClassWrapp SWIG_exception_impl("ForTrilinos::ModelEvaluator< SC,LO,GO,NO >::evaluate_jacobian(Teuchos::RCP< ForTrilinos::ModelEvaluator< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::MultiVector const > const &,Teuchos::RCP< ForTrilinos::ModelEvaluator< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::Operator > &) const", SWIG_UnknownError, "An unknown exception occurred", return ); } } - } @@ -1553,7 +1584,6 @@ SWIGEXPORT void _wrap_ForTrilinosModelEvaluator_evaluate_preconditioner(SwigClas SWIG_exception_impl("ForTrilinos::ModelEvaluator< SC,LO,GO,NO >::evaluate_preconditioner(Teuchos::RCP< ForTrilinos::ModelEvaluator< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::MultiVector const > const &,Teuchos::RCP< ForTrilinos::ModelEvaluator< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::Operator > &) const", SWIG_UnknownError, "An unknown exception occurred", return ); } } - } @@ -1700,11 +1730,10 @@ SWIGEXPORT void _wrap_ForTrilinosModelEvaluator_setup(SwigClassWrapper const *fa SWIG_exception_impl("ForTrilinos::ModelEvaluator< SC,LO,GO,NO >::setup(Teuchos::RCP< Teuchos::ParameterList > &)", SWIG_UnknownError, "An unknown exception occurred", return ); } } - } -SWIGEXPORT void _wrap_delete_ForTrilinosModelEvaluator(SwigClassWrapper const *farg1) { +SWIGEXPORT void _wrap_delete_ForTrilinosModelEvaluator(SwigClassWrapper *farg1) { ForTrilinos::ModelEvaluator< SC,LO,GO,NO > *arg1 = (ForTrilinos::ModelEvaluator< SC,LO,GO,NO > *) 0 ; Teuchos::RCP< ForTrilinos::ModelEvaluator< SC,LO,GO,NO > > *smartarg1 ; @@ -1733,15 +1762,41 @@ SWIGEXPORT void _wrap_delete_ForTrilinosModelEvaluator(SwigClassWrapper const *f SWIG_exception_impl("ForTrilinos::ModelEvaluator< SC,LO,GO,NO >::~ModelEvaluator()", SWIG_UnknownError, "An unknown exception occurred", return ); } } - } -SWIGEXPORT void _wrap_assign_ForTrilinosModelEvaluator(SwigClassWrapper * self, SwigClassWrapper const * other) { - typedef Teuchos::RCP< ForTrilinos::ModelEvaluator > swig_lhs_classtype; - SWIG_assign(swig_lhs_classtype, self, - swig_lhs_classtype, const_cast(other), - 0 | swig::IS_DESTR); +SWIGEXPORT void _wrap_ForTrilinosModelEvaluator_op_assign__(SwigClassWrapper *farg1, SwigClassWrapper const *farg2) { + ForTrilinos::ModelEvaluator< SC,LO,GO,NO > *arg1 = (ForTrilinos::ModelEvaluator< SC,LO,GO,NO > *) 0 ; + ForTrilinos::ModelEvaluator< SC,LO,GO,NO > *arg2 = 0 ; + Teuchos::RCP< ForTrilinos::ModelEvaluator< SC,LO,GO,NO > > *smartarg1 ; + + smartarg1 = static_cast< Teuchos::RCP< ForTrilinos::ModelEvaluator >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< ForTrilinos::ModelEvaluator* >(smartarg1->get()) : NULL; + (void)sizeof(arg2); + { + // Make sure no unhandled exceptions exist before performing a new action + SWIG_check_unhandled_exception_impl("ForTrilinos::ModelEvaluator< SC,LO,GO,NO >::operator =(ForTrilinos::ModelEvaluator< SC,LO,GO,NO > const &)");; + try + { + // Attempt the wrapped function call + typedef Teuchos::RCP< ForTrilinos::ModelEvaluator > swig_lhs_classtype; + SWIG_assign(swig_lhs_classtype, farg1, swig_lhs_classtype, farg2, 0 | swig::IS_DESTR); + } + catch (const std::range_error& e) + { + // Store a C++ exception + SWIG_exception_impl("ForTrilinos::ModelEvaluator< SC,LO,GO,NO >::operator =(ForTrilinos::ModelEvaluator< SC,LO,GO,NO > const &)", SWIG_IndexError, e.what(), return ); + } + catch (const std::exception& e) + { + // Store a C++ exception + SWIG_exception_impl("ForTrilinos::ModelEvaluator< SC,LO,GO,NO >::operator =(ForTrilinos::ModelEvaluator< SC,LO,GO,NO > const &)", SWIG_RuntimeError, e.what(), return ); + } + catch (...) + { + SWIG_exception_impl("ForTrilinos::ModelEvaluator< SC,LO,GO,NO >::operator =(ForTrilinos::ModelEvaluator< SC,LO,GO,NO > const &)", SWIG_UnknownError, "An unknown exception occurred", return ); + } + } } @@ -1812,7 +1867,6 @@ SWIGEXPORT void _wrap_ForModelEvaluator_init(SwigClassWrapper const *farg1, void SWIG_exception_impl("ForModelEvaluator::init(void *)", SWIG_UnknownError, "An unknown exception occurred", return ); } } - } @@ -1848,7 +1902,6 @@ SWIGEXPORT void _wrap_ForModelEvaluator_setup(SwigClassWrapper const *farg1, Swi SWIG_exception_impl("ForModelEvaluator::setup(Teuchos::RCP< Teuchos::ParameterList > &)", SWIG_UnknownError, "An unknown exception occurred", return ); } } - } @@ -1887,7 +1940,6 @@ SWIGEXPORT void _wrap_ForModelEvaluator_evaluate_residual(SwigClassWrapper const SWIG_exception_impl("ForModelEvaluator::evaluate_residual(Teuchos::RCP< ForModelEvaluator::multivector_type const > const &,Teuchos::RCP< ForModelEvaluator::multivector_type > &) const", SWIG_UnknownError, "An unknown exception occurred", return ); } } - } @@ -1926,7 +1978,6 @@ SWIGEXPORT void _wrap_ForModelEvaluator_evaluate_jacobian(SwigClassWrapper const SWIG_exception_impl("ForModelEvaluator::evaluate_jacobian(Teuchos::RCP< ForModelEvaluator::multivector_type const > const &,Teuchos::RCP< ForModelEvaluator::operator_type > &) const", SWIG_UnknownError, "An unknown exception occurred", return ); } } - } @@ -1965,7 +2016,6 @@ SWIGEXPORT void _wrap_ForModelEvaluator_evaluate_preconditioner(SwigClassWrapper SWIG_exception_impl("ForModelEvaluator::evaluate_preconditioner(Teuchos::RCP< ForModelEvaluator::multivector_type const > const &,Teuchos::RCP< ForModelEvaluator::operator_type > &) const", SWIG_UnknownError, "An unknown exception occurred", return ); } } - } @@ -2113,7 +2163,7 @@ SWIGEXPORT SwigClassWrapper _wrap_new_ForModelEvaluator() { } -SWIGEXPORT void _wrap_delete_ForModelEvaluator(SwigClassWrapper const *farg1) { +SWIGEXPORT void _wrap_delete_ForModelEvaluator(SwigClassWrapper *farg1) { ForModelEvaluator *arg1 = (ForModelEvaluator *) 0 ; Teuchos::RCP< ForModelEvaluator > *smartarg1 ; @@ -2142,15 +2192,44 @@ SWIGEXPORT void _wrap_delete_ForModelEvaluator(SwigClassWrapper const *farg1) { SWIG_exception_impl("ForModelEvaluator::~ForModelEvaluator()", SWIG_UnknownError, "An unknown exception occurred", return ); } } - } -SWIGEXPORT void _wrap_assign_ForModelEvaluator(SwigClassWrapper * self, SwigClassWrapper const * other) { - typedef Teuchos::RCP< ForModelEvaluator > swig_lhs_classtype; - SWIG_assign(swig_lhs_classtype, self, - swig_lhs_classtype, const_cast(other), - 0 | swig::IS_DESTR | swig::IS_COPY_CONSTR); +SWIGEXPORT void _wrap_ForModelEvaluator_op_assign__(SwigClassWrapper *farg1, SwigClassWrapper const *farg2) { + ForModelEvaluator *arg1 = (ForModelEvaluator *) 0 ; + ForModelEvaluator *arg2 = 0 ; + Teuchos::RCP< ForModelEvaluator > *smartarg1 ; + Teuchos::RCP< ForModelEvaluator const > *smartarg2 ; + + smartarg1 = static_cast< Teuchos::RCP< ForModelEvaluator >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< ForModelEvaluator* >(smartarg1->get()) : NULL; + SWIG_check_sp_nonnull(farg2, "ForModelEvaluator *", "ForModelEvaluator", "ForModelEvaluator::operator =(ForModelEvaluator const &)", return ) + smartarg2 = static_cast< Teuchos::RCP* >(farg2->cptr); + arg2 = const_cast< ForModelEvaluator* >(smartarg2->get()); + { + // Make sure no unhandled exceptions exist before performing a new action + SWIG_check_unhandled_exception_impl("ForModelEvaluator::operator =(ForModelEvaluator const &)");; + try + { + // Attempt the wrapped function call + typedef Teuchos::RCP< ForModelEvaluator > swig_lhs_classtype; + SWIG_assign(swig_lhs_classtype, farg1, swig_lhs_classtype, farg2, 0 | swig::IS_DESTR | swig::IS_COPY_CONSTR); + } + catch (const std::range_error& e) + { + // Store a C++ exception + SWIG_exception_impl("ForModelEvaluator::operator =(ForModelEvaluator const &)", SWIG_IndexError, e.what(), return ); + } + catch (const std::exception& e) + { + // Store a C++ exception + SWIG_exception_impl("ForModelEvaluator::operator =(ForModelEvaluator const &)", SWIG_RuntimeError, e.what(), return ); + } + catch (...) + { + SWIG_exception_impl("ForModelEvaluator::operator =(ForModelEvaluator const &)", SWIG_UnknownError, "An unknown exception occurred", return ); + } + } } @@ -2222,7 +2301,6 @@ SWIGEXPORT void _wrap_NOXSolver_setup(SwigClassWrapper const *farg1, SwigClassWr SWIG_exception_impl("ForTrilinos::NOXSolver< SC,LO,GO,NO >::setup(Teuchos::RCP< Teuchos::ParameterList > &)", SWIG_UnknownError, "An unknown exception occurred", return ); } } - } @@ -2262,7 +2340,7 @@ SWIGEXPORT int _wrap_NOXSolver_solve(SwigClassWrapper const *farg1) { } -SWIGEXPORT void _wrap_delete_NOXSolver(SwigClassWrapper const *farg1) { +SWIGEXPORT void _wrap_delete_NOXSolver(SwigClassWrapper *farg1) { ForTrilinos::NOXSolver< SC,LO,GO,NO > *arg1 = (ForTrilinos::NOXSolver< SC,LO,GO,NO > *) 0 ; Teuchos::RCP< ForTrilinos::NOXSolver< SC,LO,GO,NO > > *smartarg1 ; @@ -2291,15 +2369,41 @@ SWIGEXPORT void _wrap_delete_NOXSolver(SwigClassWrapper const *farg1) { SWIG_exception_impl("ForTrilinos::NOXSolver< SC,LO,GO,NO >::~NOXSolver()", SWIG_UnknownError, "An unknown exception occurred", return ); } } - } -SWIGEXPORT void _wrap_assign_NOXSolver(SwigClassWrapper * self, SwigClassWrapper const * other) { - typedef Teuchos::RCP< ForTrilinos::NOXSolver > swig_lhs_classtype; - SWIG_assign(swig_lhs_classtype, self, - swig_lhs_classtype, const_cast(other), - 0 | swig::IS_DESTR | swig::IS_COPY_CONSTR); +SWIGEXPORT void _wrap_NOXSolver_op_assign__(SwigClassWrapper *farg1, SwigClassWrapper const *farg2) { + ForTrilinos::NOXSolver< SC,LO,GO,NO > *arg1 = (ForTrilinos::NOXSolver< SC,LO,GO,NO > *) 0 ; + ForTrilinos::NOXSolver< SC,LO,GO,NO > *arg2 = 0 ; + Teuchos::RCP< ForTrilinos::NOXSolver< SC,LO,GO,NO > > *smartarg1 ; + + smartarg1 = static_cast< Teuchos::RCP< ForTrilinos::NOXSolver >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< ForTrilinos::NOXSolver* >(smartarg1->get()) : NULL; + (void)sizeof(arg2); + { + // Make sure no unhandled exceptions exist before performing a new action + SWIG_check_unhandled_exception_impl("ForTrilinos::NOXSolver< SC,LO,GO,NO >::operator =(ForTrilinos::NOXSolver< SC,LO,GO,NO > const &)");; + try + { + // Attempt the wrapped function call + typedef Teuchos::RCP< ForTrilinos::NOXSolver > swig_lhs_classtype; + SWIG_assign(swig_lhs_classtype, farg1, swig_lhs_classtype, farg2, 0 | swig::IS_DESTR | swig::IS_COPY_CONSTR); + } + catch (const std::range_error& e) + { + // Store a C++ exception + SWIG_exception_impl("ForTrilinos::NOXSolver< SC,LO,GO,NO >::operator =(ForTrilinos::NOXSolver< SC,LO,GO,NO > const &)", SWIG_IndexError, e.what(), return ); + } + catch (const std::exception& e) + { + // Store a C++ exception + SWIG_exception_impl("ForTrilinos::NOXSolver< SC,LO,GO,NO >::operator =(ForTrilinos::NOXSolver< SC,LO,GO,NO > const &)", SWIG_RuntimeError, e.what(), return ); + } + catch (...) + { + SWIG_exception_impl("ForTrilinos::NOXSolver< SC,LO,GO,NO >::operator =(ForTrilinos::NOXSolver< SC,LO,GO,NO > const &)", SWIG_UnknownError, "An unknown exception occurred", return ); + } + } } diff --git a/src/interface/test/Tpetra_ModelEvaluator_1DFEM.F90 b/src/interface/test/Tpetra_ModelEvaluator_1DFEM.F90 index 0f9a1e07..27cabeed 100644 --- a/src/interface/test/Tpetra_ModelEvaluator_1DFEM.F90 +++ b/src/interface/test/Tpetra_ModelEvaluator_1DFEM.F90 @@ -281,7 +281,7 @@ subroutine TpetraModelEvaluator1DFEM_eval_resid(self, x, f) ! ------------------------------------------------------------------------ ! class(TpetraModelEvaluator1DFEM), intent(in) :: self class(TpetraMultiVector), intent(in) :: x - class(TpetraMultiVector), intent(inout) :: f + class(TpetraMultiVector), intent(in) :: f type(Linear2NodeFEBasis) :: basis integer :: num_my_elems, ne, gp, i, lclrow integer(size_type) :: col @@ -353,7 +353,7 @@ subroutine TpetraModelEvaluator1DFEM_eval_jac(self, x, J) ! ------------------------------------------------------------------------ ! class(TpetraMultiVector), intent(in) :: x class(TpetraModelEvaluator1DFEM), intent(in) :: self - class(TpetraOperator), intent(inout) :: J + class(TpetraOperator), intent(in) :: J type(TpetraCrsMatrix) :: Jmat type(Linear2NodeFEBasis) :: basis integer :: ne, num_my_elems, gp, i, jj @@ -443,7 +443,7 @@ subroutine TpetraModelEvaluator1DFEM_eval_prec(self, x, M) ! ------------------------------------------------------------------------ ! class(TpetraModelEvaluator1DFEM), intent(in) :: self class(TpetraMultiVector), intent(in) :: x - class(TpetraOperator), intent(inout) :: M + class(TpetraOperator), intent(in) :: M type(TpetraCrsMatrix) :: Mmat type(TpetraMap) :: row_map, col_map type(Linear2NodeFEBasis) :: basis diff --git a/src/interface/test/test_solver_handle.F90 b/src/interface/test/test_solver_handle.F90 index 052f4f96..811fd190 100644 --- a/src/interface/test/test_solver_handle.F90 +++ b/src/interface/test/test_solver_handle.F90 @@ -37,7 +37,7 @@ subroutine my_apply(self, x, y, mode, alpha, beta) implicit none class(TriDiagOperator), intent(in) :: self class(TpetraMultiVector), intent(in) :: x - class(TpetraMultiVector), intent(inout) :: y + class(TpetraMultiVector), intent(in) :: y integer(kind(TeuchosETransp)), intent(in) :: mode real(scalar_type), intent(in) :: alpha real(scalar_type), intent(in) :: beta diff --git a/src/teuchos/src/swig/forteuchos.F90 b/src/teuchos/src/swig/forteuchos.F90 index bec87902..354d2748 100644 --- a/src/teuchos/src/swig/forteuchos.F90 +++ b/src/teuchos/src/swig/forteuchos.F90 @@ -81,42 +81,54 @@ module forteuchos type(C_PTR), public :: data = C_NULL_PTR integer(C_SIZE_T), public :: size = 0 end type + type, public :: SWIGTYPE_Teuchos__ArrayT_int_t + type(SwigClassWrapper), public :: swigdata + end type ! class Teuchos::Array< int > type, public :: TeuchosArrayInt type(SwigClassWrapper), public :: swigdata contains procedure :: view => swigf_TeuchosArrayInt_view procedure :: release => delete_TeuchosArrayInt - procedure, private :: swigf_assignment_TeuchosArrayInt - generic :: assignment(=) => swigf_assignment_TeuchosArrayInt + procedure, private :: swigf_TeuchosArrayInt_op_assign__ + generic :: assignment(=) => swigf_TeuchosArrayInt_op_assign__ end type TeuchosArrayInt interface TeuchosArrayInt module procedure new_TeuchosArrayInt end interface + type, public :: SWIGTYPE_Teuchos__ArrayT_double_t + type(SwigClassWrapper), public :: swigdata + end type ! class Teuchos::Array< double > type, public :: TeuchosArrayDbl type(SwigClassWrapper), public :: swigdata contains procedure :: view => swigf_TeuchosArrayDbl_view procedure :: release => delete_TeuchosArrayDbl - procedure, private :: swigf_assignment_TeuchosArrayDbl - generic :: assignment(=) => swigf_assignment_TeuchosArrayDbl + procedure, private :: swigf_TeuchosArrayDbl_op_assign__ + generic :: assignment(=) => swigf_TeuchosArrayDbl_op_assign__ end type TeuchosArrayDbl interface TeuchosArrayDbl module procedure new_TeuchosArrayDbl end interface + type, public :: SWIGTYPE_Teuchos__ArrayT_long_long_t + type(SwigClassWrapper), public :: swigdata + end type ! class Teuchos::Array< long long > type, public :: TeuchosArrayLongLong type(SwigClassWrapper), public :: swigdata contains procedure :: view => swigf_TeuchosArrayLongLong_view procedure :: release => delete_TeuchosArrayLongLong - procedure, private :: swigf_assignment_TeuchosArrayLongLong - generic :: assignment(=) => swigf_assignment_TeuchosArrayLongLong + procedure, private :: swigf_TeuchosArrayLongLong_op_assign__ + generic :: assignment(=) => swigf_TeuchosArrayLongLong_op_assign__ end type TeuchosArrayLongLong interface TeuchosArrayLongLong module procedure new_TeuchosArrayLongLong end interface + type, public :: SWIGTYPE_Teuchos__CommT_int_t + type(SwigClassWrapper), public :: swigdata + end type ! class Teuchos::Comm< int > type, public :: TeuchosComm type(SwigClassWrapper), public :: swigdata @@ -126,12 +138,12 @@ module forteuchos procedure :: barrier => swigf_TeuchosComm_barrier procedure :: getRawMpiComm => swigf_TeuchosComm_getRawMpiComm procedure :: release => delete_TeuchosComm - procedure, private :: swigf_assignment_TeuchosComm - generic :: assignment(=) => swigf_assignment_TeuchosComm + procedure, private :: swigf_TeuchosComm_op_assign__ + generic :: assignment(=) => swigf_TeuchosComm_op_assign__ end type TeuchosComm interface TeuchosComm - module procedure new_TeuchosComm__SWIG_0 - module procedure new_TeuchosComm__SWIG_1 + module procedure swigf_new_TeuchosComm__SWIG_0 + module procedure swigf_new_TeuchosComm__SWIG_1 end interface ! class Teuchos::ParameterList type, public :: ParameterList @@ -141,15 +153,15 @@ module forteuchos procedure :: remove => swigf_ParameterList_remove procedure :: is_parameter => swigf_ParameterList_is_parameter procedure :: sublist => swigf_ParameterList_sublist - procedure, private :: set__SWIG_1 => swigf_ParameterList_set__SWIG_1 - procedure, private :: set__SWIG_2 => swigf_ParameterList_set__SWIG_2 - procedure, private :: set__SWIG_3 => swigf_ParameterList_set__SWIG_3 - procedure, private :: set__SWIG_4 => swigf_ParameterList_set__SWIG_4 - procedure, private :: set__SWIG_5 => swigf_ParameterList_set__SWIG_5 - procedure, private :: set__SWIG_6 => swigf_ParameterList_set__SWIG_6 - procedure, private :: set__SWIG_7 => swigf_ParameterList_set__SWIG_7 - procedure, private :: set__SWIG_8 => swigf_ParameterList_set__SWIG_8 - procedure, private :: set__SWIG_9 => swigf_ParameterList_set__SWIG_9 + procedure, private :: swigf_ParameterList_set__SWIG_1 + procedure, private :: swigf_ParameterList_set__SWIG_2 + procedure, private :: swigf_ParameterList_set__SWIG_3 + procedure, private :: swigf_ParameterList_set__SWIG_4 + procedure, private :: swigf_ParameterList_set__SWIG_5 + procedure, private :: swigf_ParameterList_set__SWIG_6 + procedure, private :: swigf_ParameterList_set__SWIG_7 + procedure, private :: swigf_ParameterList_set__SWIG_8 + procedure, private :: swigf_ParameterList_set__SWIG_9 procedure :: get_real => swigf_ParameterList_get_real procedure :: get_integer => swigf_ParameterList_get_integer procedure :: get_longlong => swigf_ParameterList_get_longlong @@ -159,14 +171,15 @@ module forteuchos procedure :: get_arr_integer => swigf_ParameterList_get_arr_integer procedure :: get_arr_longlong => swigf_ParameterList_get_arr_longlong procedure :: release => delete_ParameterList - procedure, private :: swigf_assignment_ParameterList - generic :: assignment(=) => swigf_assignment_ParameterList - generic :: set => set__SWIG_1, set__SWIG_2, set__SWIG_3, set__SWIG_4, set__SWIG_5, set__SWIG_6, set__SWIG_7, set__SWIG_8, & - set__SWIG_9 + procedure, private :: swigf_ParameterList_op_assign__ + generic :: assignment(=) => swigf_ParameterList_op_assign__ + generic :: set => swigf_ParameterList_set__SWIG_1, swigf_ParameterList_set__SWIG_2, swigf_ParameterList_set__SWIG_3, & + swigf_ParameterList_set__SWIG_4, swigf_ParameterList_set__SWIG_5, swigf_ParameterList_set__SWIG_6, & + swigf_ParameterList_set__SWIG_7, swigf_ParameterList_set__SWIG_8, swigf_ParameterList_set__SWIG_9 end type ParameterList interface ParameterList - module procedure new_ParameterList__SWIG_0 - module procedure new_ParameterList__SWIG_1 + module procedure swigf_new_ParameterList__SWIG_0 + module procedure swigf_new_ParameterList__SWIG_1 end interface public :: load_from_xml public :: save_to_xml @@ -197,16 +210,17 @@ subroutine swigc_delete_TeuchosArrayInt(farg1) & bind(C, name="_wrap_delete_TeuchosArrayInt") use, intrinsic :: ISO_C_BINDING import :: swigclasswrapper -type(SwigClassWrapper) :: farg1 +type(SwigClassWrapper), intent(inout) :: farg1 +end subroutine + +subroutine swigc_TeuchosArrayInt_op_assign__(farg1, farg2) & +bind(C, name="_wrap_TeuchosArrayInt_op_assign__") +use, intrinsic :: ISO_C_BINDING +import :: swigclasswrapper +type(SwigClassWrapper), intent(inout) :: farg1 +type(SwigClassWrapper) :: farg2 end subroutine - subroutine swigc_assignment_TeuchosArrayInt(self, other) & - bind(C, name="_wrap_assign_TeuchosArrayInt") - use, intrinsic :: ISO_C_BINDING - import :: SwigClassWrapper - type(SwigClassWrapper), intent(inout) :: self - type(SwigClassWrapper), intent(in) :: other - end subroutine function swigc_new_TeuchosArrayDbl(farg1) & bind(C, name="_wrap_new_TeuchosArrayDbl") & result(fresult) @@ -231,16 +245,17 @@ subroutine swigc_delete_TeuchosArrayDbl(farg1) & bind(C, name="_wrap_delete_TeuchosArrayDbl") use, intrinsic :: ISO_C_BINDING import :: swigclasswrapper -type(SwigClassWrapper) :: farg1 +type(SwigClassWrapper), intent(inout) :: farg1 +end subroutine + +subroutine swigc_TeuchosArrayDbl_op_assign__(farg1, farg2) & +bind(C, name="_wrap_TeuchosArrayDbl_op_assign__") +use, intrinsic :: ISO_C_BINDING +import :: swigclasswrapper +type(SwigClassWrapper), intent(inout) :: farg1 +type(SwigClassWrapper) :: farg2 end subroutine - subroutine swigc_assignment_TeuchosArrayDbl(self, other) & - bind(C, name="_wrap_assign_TeuchosArrayDbl") - use, intrinsic :: ISO_C_BINDING - import :: SwigClassWrapper - type(SwigClassWrapper), intent(inout) :: self - type(SwigClassWrapper), intent(in) :: other - end subroutine function swigc_new_TeuchosArrayLongLong(farg1) & bind(C, name="_wrap_new_TeuchosArrayLongLong") & result(fresult) @@ -265,16 +280,17 @@ subroutine swigc_delete_TeuchosArrayLongLong(farg1) & bind(C, name="_wrap_delete_TeuchosArrayLongLong") use, intrinsic :: ISO_C_BINDING import :: swigclasswrapper -type(SwigClassWrapper) :: farg1 +type(SwigClassWrapper), intent(inout) :: farg1 +end subroutine + +subroutine swigc_TeuchosArrayLongLong_op_assign__(farg1, farg2) & +bind(C, name="_wrap_TeuchosArrayLongLong_op_assign__") +use, intrinsic :: ISO_C_BINDING +import :: swigclasswrapper +type(SwigClassWrapper), intent(inout) :: farg1 +type(SwigClassWrapper) :: farg2 end subroutine - subroutine swigc_assignment_TeuchosArrayLongLong(self, other) & - bind(C, name="_wrap_assign_TeuchosArrayLongLong") - use, intrinsic :: ISO_C_BINDING - import :: SwigClassWrapper - type(SwigClassWrapper), intent(inout) :: self - type(SwigClassWrapper), intent(in) :: other - end subroutine function swigc_TeuchosComm_getRank(farg1) & bind(C, name="_wrap_TeuchosComm_getRank") & result(fresult) @@ -330,16 +346,17 @@ subroutine swigc_delete_TeuchosComm(farg1) & bind(C, name="_wrap_delete_TeuchosComm") use, intrinsic :: ISO_C_BINDING import :: swigclasswrapper -type(SwigClassWrapper) :: farg1 +type(SwigClassWrapper), intent(inout) :: farg1 +end subroutine + +subroutine swigc_TeuchosComm_op_assign__(farg1, farg2) & +bind(C, name="_wrap_TeuchosComm_op_assign__") +use, intrinsic :: ISO_C_BINDING +import :: swigclasswrapper +type(SwigClassWrapper), intent(inout) :: farg1 +type(SwigClassWrapper) :: farg2 end subroutine - subroutine swigc_assignment_TeuchosComm(self, other) & - bind(C, name="_wrap_assign_TeuchosComm") - use, intrinsic :: ISO_C_BINDING - import :: SwigClassWrapper - type(SwigClassWrapper), intent(inout) :: self - type(SwigClassWrapper), intent(in) :: other - end subroutine function swigc_new_ParameterList__SWIG_0() & bind(C, name="_wrap_new_ParameterList__SWIG_0") & result(fresult) @@ -578,16 +595,17 @@ subroutine swigc_delete_ParameterList(farg1) & bind(C, name="_wrap_delete_ParameterList") use, intrinsic :: ISO_C_BINDING import :: swigclasswrapper -type(SwigClassWrapper) :: farg1 +type(SwigClassWrapper), intent(inout) :: farg1 +end subroutine + +subroutine swigc_ParameterList_op_assign__(farg1, farg2) & +bind(C, name="_wrap_ParameterList_op_assign__") +use, intrinsic :: ISO_C_BINDING +import :: swigclasswrapper +type(SwigClassWrapper), intent(inout) :: farg1 +type(SwigClassWrapper) :: farg2 end subroutine - subroutine swigc_assignment_ParameterList(self, other) & - bind(C, name="_wrap_assign_ParameterList") - use, intrinsic :: ISO_C_BINDING - import :: SwigClassWrapper - type(SwigClassWrapper), intent(inout) :: self - type(SwigClassWrapper), intent(in) :: other - end subroutine subroutine swigc_load_from_xml(farg1, farg2) & bind(C, name="_wrap_load_from_xml") use, intrinsic :: ISO_C_BINDING @@ -617,7 +635,6 @@ function new_TeuchosArrayInt(arg0) & type(TeuchosArrayInt) :: self integer(C_INT), dimension(:), target :: arg0 integer(C_INT), pointer :: farg1_view - type(SwigClassWrapper) :: fresult type(SwigArrayWrapper) :: farg1 @@ -637,8 +654,7 @@ function swigf_TeuchosArrayInt_view(self) & result(swig_result) use, intrinsic :: ISO_C_BINDING integer(C_INT), dimension(:), pointer :: swig_result -class(TeuchosArrayInt), intent(inout) :: self - +class(TeuchosArrayInt), intent(in) :: self type(SwigArrayWrapper) :: fresult type(SwigClassWrapper) :: farg1 @@ -654,7 +670,6 @@ function swigf_TeuchosArrayInt_view(self) & subroutine delete_TeuchosArrayInt(self) use, intrinsic :: ISO_C_BINDING class(TeuchosArrayInt), intent(inout) :: self - type(SwigClassWrapper) :: farg1 farg1 = self%swigdata @@ -665,19 +680,25 @@ subroutine delete_TeuchosArrayInt(self) self%swigdata%mem = SWIG_NULL end subroutine - subroutine swigf_assignment_TeuchosArrayInt(self, other) - use, intrinsic :: ISO_C_BINDING - class(TeuchosArrayInt), intent(inout) :: self - type(TeuchosArrayInt), intent(in) :: other - call swigc_assignment_TeuchosArrayInt(self%swigdata, other%swigdata) - end subroutine +subroutine swigf_TeuchosArrayInt_op_assign__(self, other) +use, intrinsic :: ISO_C_BINDING +class(TeuchosArrayInt), intent(inout) :: self +type(SWIGTYPE_Teuchos__ArrayT_int_t), intent(in) :: other +type(SwigClassWrapper) :: farg1 +type(SwigClassWrapper) :: farg2 + +farg1 = self%swigdata +farg2 = other%swigdata +call swigc_TeuchosArrayInt_op_assign__(farg1, farg2) +self%swigdata = farg1 +end subroutine + function new_TeuchosArrayDbl(arg0) & result(self) use, intrinsic :: ISO_C_BINDING type(TeuchosArrayDbl) :: self real(C_DOUBLE), dimension(:), target :: arg0 real(C_DOUBLE), pointer :: farg1_view - type(SwigClassWrapper) :: fresult type(SwigArrayWrapper) :: farg1 @@ -697,8 +718,7 @@ function swigf_TeuchosArrayDbl_view(self) & result(swig_result) use, intrinsic :: ISO_C_BINDING real(C_DOUBLE), dimension(:), pointer :: swig_result -class(TeuchosArrayDbl), intent(inout) :: self - +class(TeuchosArrayDbl), intent(in) :: self type(SwigArrayWrapper) :: fresult type(SwigClassWrapper) :: farg1 @@ -714,7 +734,6 @@ function swigf_TeuchosArrayDbl_view(self) & subroutine delete_TeuchosArrayDbl(self) use, intrinsic :: ISO_C_BINDING class(TeuchosArrayDbl), intent(inout) :: self - type(SwigClassWrapper) :: farg1 farg1 = self%swigdata @@ -725,19 +744,25 @@ subroutine delete_TeuchosArrayDbl(self) self%swigdata%mem = SWIG_NULL end subroutine - subroutine swigf_assignment_TeuchosArrayDbl(self, other) - use, intrinsic :: ISO_C_BINDING - class(TeuchosArrayDbl), intent(inout) :: self - type(TeuchosArrayDbl), intent(in) :: other - call swigc_assignment_TeuchosArrayDbl(self%swigdata, other%swigdata) - end subroutine +subroutine swigf_TeuchosArrayDbl_op_assign__(self, other) +use, intrinsic :: ISO_C_BINDING +class(TeuchosArrayDbl), intent(inout) :: self +type(SWIGTYPE_Teuchos__ArrayT_double_t), intent(in) :: other +type(SwigClassWrapper) :: farg1 +type(SwigClassWrapper) :: farg2 + +farg1 = self%swigdata +farg2 = other%swigdata +call swigc_TeuchosArrayDbl_op_assign__(farg1, farg2) +self%swigdata = farg1 +end subroutine + function new_TeuchosArrayLongLong(arg0) & result(self) use, intrinsic :: ISO_C_BINDING type(TeuchosArrayLongLong) :: self integer(C_LONG_LONG), dimension(:), target :: arg0 integer(C_LONG_LONG), pointer :: farg1_view - type(SwigClassWrapper) :: fresult type(SwigArrayWrapper) :: farg1 @@ -757,8 +782,7 @@ function swigf_TeuchosArrayLongLong_view(self) & result(swig_result) use, intrinsic :: ISO_C_BINDING integer(C_LONG_LONG), dimension(:), pointer :: swig_result -class(TeuchosArrayLongLong), intent(inout) :: self - +class(TeuchosArrayLongLong), intent(in) :: self type(SwigArrayWrapper) :: fresult type(SwigClassWrapper) :: farg1 @@ -774,7 +798,6 @@ function swigf_TeuchosArrayLongLong_view(self) & subroutine delete_TeuchosArrayLongLong(self) use, intrinsic :: ISO_C_BINDING class(TeuchosArrayLongLong), intent(inout) :: self - type(SwigClassWrapper) :: farg1 farg1 = self%swigdata @@ -785,18 +808,24 @@ subroutine delete_TeuchosArrayLongLong(self) self%swigdata%mem = SWIG_NULL end subroutine - subroutine swigf_assignment_TeuchosArrayLongLong(self, other) - use, intrinsic :: ISO_C_BINDING - class(TeuchosArrayLongLong), intent(inout) :: self - type(TeuchosArrayLongLong), intent(in) :: other - call swigc_assignment_TeuchosArrayLongLong(self%swigdata, other%swigdata) - end subroutine +subroutine swigf_TeuchosArrayLongLong_op_assign__(self, other) +use, intrinsic :: ISO_C_BINDING +class(TeuchosArrayLongLong), intent(inout) :: self +type(SWIGTYPE_Teuchos__ArrayT_long_long_t), intent(in) :: other +type(SwigClassWrapper) :: farg1 +type(SwigClassWrapper) :: farg2 + +farg1 = self%swigdata +farg2 = other%swigdata +call swigc_TeuchosArrayLongLong_op_assign__(farg1, farg2) +self%swigdata = farg1 +end subroutine + function swigf_TeuchosComm_getRank(self) & result(swig_result) use, intrinsic :: ISO_C_BINDING integer :: swig_result class(TeuchosComm), intent(in) :: self - integer(C_INT) :: fresult type(SwigClassWrapper) :: farg1 @@ -810,7 +839,6 @@ function swigf_TeuchosComm_getSize(self) & use, intrinsic :: ISO_C_BINDING integer :: swig_result class(TeuchosComm), intent(in) :: self - integer(C_INT) :: fresult type(SwigClassWrapper) :: farg1 @@ -822,19 +850,17 @@ function swigf_TeuchosComm_getSize(self) & subroutine swigf_TeuchosComm_barrier(self) use, intrinsic :: ISO_C_BINDING class(TeuchosComm), intent(in) :: self - type(SwigClassWrapper) :: farg1 farg1 = self%swigdata call swigc_TeuchosComm_barrier(farg1) end subroutine -function new_TeuchosComm__SWIG_0(rawmpicomm) & +function swigf_new_TeuchosComm__SWIG_0(rawmpicomm) & result(self) use, intrinsic :: ISO_C_BINDING type(TeuchosComm) :: self integer :: rawmpicomm - type(SwigClassWrapper) :: fresult integer(C_INT) :: farg1 @@ -843,11 +869,10 @@ function new_TeuchosComm__SWIG_0(rawmpicomm) & self%swigdata = fresult end function -function new_TeuchosComm__SWIG_1() & +function swigf_new_TeuchosComm__SWIG_1() & result(self) use, intrinsic :: ISO_C_BINDING type(TeuchosComm) :: self - type(SwigClassWrapper) :: fresult fresult = swigc_new_TeuchosComm__SWIG_1() @@ -858,8 +883,7 @@ function swigf_TeuchosComm_getRawMpiComm(self) & result(swig_result) use, intrinsic :: ISO_C_BINDING integer :: swig_result -class(TeuchosComm), intent(inout) :: self - +class(TeuchosComm), intent(in) :: self integer(C_INT) :: fresult type(SwigClassWrapper) :: farg1 @@ -871,7 +895,6 @@ function swigf_TeuchosComm_getRawMpiComm(self) & subroutine delete_TeuchosComm(self) use, intrinsic :: ISO_C_BINDING class(TeuchosComm), intent(inout) :: self - type(SwigClassWrapper) :: farg1 farg1 = self%swigdata @@ -882,17 +905,23 @@ subroutine delete_TeuchosComm(self) self%swigdata%mem = SWIG_NULL end subroutine - subroutine swigf_assignment_TeuchosComm(self, other) - use, intrinsic :: ISO_C_BINDING - class(TeuchosComm), intent(inout) :: self - type(TeuchosComm), intent(in) :: other - call swigc_assignment_TeuchosComm(self%swigdata, other%swigdata) - end subroutine -function new_ParameterList__SWIG_0() & +subroutine swigf_TeuchosComm_op_assign__(self, other) +use, intrinsic :: ISO_C_BINDING +class(TeuchosComm), intent(inout) :: self +type(SWIGTYPE_Teuchos__CommT_int_t), intent(in) :: other +type(SwigClassWrapper) :: farg1 +type(SwigClassWrapper) :: farg2 + +farg1 = self%swigdata +farg2 = other%swigdata +call swigc_TeuchosComm_op_assign__(farg1, farg2) +self%swigdata = farg1 +end subroutine + +function swigf_new_ParameterList__SWIG_0() & result(self) use, intrinsic :: ISO_C_BINDING type(ParameterList) :: self - type(SwigClassWrapper) :: fresult fresult = swigc_new_ParameterList__SWIG_0() @@ -917,13 +946,12 @@ subroutine SWIG_string_to_chararray(string, chars, wrap) wrap%size = len(string) end subroutine -function new_ParameterList__SWIG_1(name) & +function swigf_new_ParameterList__SWIG_1(name) & result(self) use, intrinsic :: ISO_C_BINDING type(ParameterList) :: self character(kind=C_CHAR, len=*), target :: name character(kind=C_CHAR), dimension(:), allocatable, target :: farg1_chars - type(SwigClassWrapper) :: fresult type(SwigArrayWrapper) :: farg1 @@ -935,7 +963,6 @@ function new_ParameterList__SWIG_1(name) & subroutine swigf_ParameterList_print(self) use, intrinsic :: ISO_C_BINDING class(ParameterList), intent(in) :: self - type(SwigClassWrapper) :: farg1 farg1 = self%swigdata @@ -944,11 +971,9 @@ subroutine swigf_ParameterList_print(self) subroutine swigf_ParameterList_remove(self, name) use, intrinsic :: ISO_C_BINDING -class(ParameterList), intent(inout) :: self - +class(ParameterList), intent(in) :: self character(kind=C_CHAR, len=*), target :: name character(kind=C_CHAR), dimension(:), allocatable, target :: farg2_chars - type(SwigClassWrapper) :: farg1 type(SwigArrayWrapper) :: farg2 @@ -975,10 +1000,8 @@ function swigf_ParameterList_is_parameter(self, name) & use, intrinsic :: ISO_C_BINDING logical :: swig_result class(ParameterList), intent(in) :: self - character(kind=C_CHAR, len=*), target :: name character(kind=C_CHAR), dimension(:), allocatable, target :: farg2_chars - integer(C_INT) :: fresult type(SwigClassWrapper) :: farg1 type(SwigArrayWrapper) :: farg2 @@ -993,11 +1016,9 @@ function swigf_ParameterList_sublist(self, name) & result(swig_result) use, intrinsic :: ISO_C_BINDING type(ParameterList) :: swig_result -class(ParameterList), intent(inout) :: self - +class(ParameterList), intent(in) :: self character(kind=C_CHAR, len=*), target :: name character(kind=C_CHAR), dimension(:), allocatable, target :: farg2_chars - type(SwigClassWrapper) :: fresult type(SwigClassWrapper) :: farg1 type(SwigArrayWrapper) :: farg2 @@ -1010,12 +1031,10 @@ function swigf_ParameterList_sublist(self, name) & subroutine swigf_ParameterList_set__SWIG_1(self, name, value) use, intrinsic :: ISO_C_BINDING -class(ParameterList), intent(inout) :: self - +class(ParameterList), intent(in) :: self character(kind=C_CHAR, len=*), target :: name character(kind=C_CHAR), dimension(:), allocatable, target :: farg2_chars real(C_DOUBLE), intent(in) :: value - type(SwigClassWrapper) :: farg1 type(SwigArrayWrapper) :: farg2 real(C_DOUBLE) :: farg3 @@ -1028,12 +1047,10 @@ subroutine swigf_ParameterList_set__SWIG_1(self, name, value) subroutine swigf_ParameterList_set__SWIG_2(self, name, value) use, intrinsic :: ISO_C_BINDING -class(ParameterList), intent(inout) :: self - +class(ParameterList), intent(in) :: self character(kind=C_CHAR, len=*), target :: name character(kind=C_CHAR), dimension(:), allocatable, target :: farg2_chars integer, intent(in) :: value - type(SwigClassWrapper) :: farg1 type(SwigArrayWrapper) :: farg2 integer(C_INT) :: farg3 @@ -1046,12 +1063,10 @@ subroutine swigf_ParameterList_set__SWIG_2(self, name, value) subroutine swigf_ParameterList_set__SWIG_3(self, name, value) use, intrinsic :: ISO_C_BINDING -class(ParameterList), intent(inout) :: self - +class(ParameterList), intent(in) :: self character(kind=C_CHAR, len=*), target :: name character(kind=C_CHAR), dimension(:), allocatable, target :: farg2_chars integer(C_LONG_LONG), intent(in) :: value - type(SwigClassWrapper) :: farg1 type(SwigArrayWrapper) :: farg2 integer(C_LONG_LONG) :: farg3 @@ -1077,12 +1092,10 @@ function SWIG_logical_to_int(inp) & subroutine swigf_ParameterList_set__SWIG_4(self, name, value) use, intrinsic :: ISO_C_BINDING -class(ParameterList), intent(inout) :: self - +class(ParameterList), intent(in) :: self character(kind=C_CHAR, len=*), target :: name character(kind=C_CHAR), dimension(:), allocatable, target :: farg2_chars logical, intent(in) :: value - type(SwigClassWrapper) :: farg1 type(SwigArrayWrapper) :: farg2 integer(C_INT) :: farg3 @@ -1095,13 +1108,11 @@ subroutine swigf_ParameterList_set__SWIG_4(self, name, value) subroutine swigf_ParameterList_set__SWIG_5(self, name, value) use, intrinsic :: ISO_C_BINDING -class(ParameterList), intent(inout) :: self - +class(ParameterList), intent(in) :: self character(kind=C_CHAR, len=*), target :: name character(kind=C_CHAR), dimension(:), allocatable, target :: farg2_chars character(kind=C_CHAR, len=*), target :: value character(kind=C_CHAR), dimension(:), allocatable, target :: farg3_chars - type(SwigClassWrapper) :: farg1 type(SwigArrayWrapper) :: farg2 type(SwigArrayWrapper) :: farg3 @@ -1114,13 +1125,11 @@ subroutine swigf_ParameterList_set__SWIG_5(self, name, value) subroutine swigf_ParameterList_set__SWIG_6(self, name, value) use, intrinsic :: ISO_C_BINDING -class(ParameterList), intent(inout) :: self - +class(ParameterList), intent(in) :: self character(kind=C_CHAR, len=*), target :: name character(kind=C_CHAR), dimension(:), allocatable, target :: farg2_chars real(C_DOUBLE), dimension(:), target :: value real(C_DOUBLE), pointer :: farg3_view - type(SwigClassWrapper) :: farg1 type(SwigArrayWrapper) :: farg2 type(SwigArrayWrapper) :: farg3 @@ -1140,13 +1149,11 @@ subroutine swigf_ParameterList_set__SWIG_6(self, name, value) subroutine swigf_ParameterList_set__SWIG_7(self, name, value) use, intrinsic :: ISO_C_BINDING -class(ParameterList), intent(inout) :: self - +class(ParameterList), intent(in) :: self character(kind=C_CHAR, len=*), target :: name character(kind=C_CHAR), dimension(:), allocatable, target :: farg2_chars integer(C_INT), dimension(:), target :: value integer(C_INT), pointer :: farg3_view - type(SwigClassWrapper) :: farg1 type(SwigArrayWrapper) :: farg2 type(SwigArrayWrapper) :: farg3 @@ -1166,13 +1173,11 @@ subroutine swigf_ParameterList_set__SWIG_7(self, name, value) subroutine swigf_ParameterList_set__SWIG_8(self, name, value) use, intrinsic :: ISO_C_BINDING -class(ParameterList), intent(inout) :: self - +class(ParameterList), intent(in) :: self character(kind=C_CHAR, len=*), target :: name character(kind=C_CHAR), dimension(:), allocatable, target :: farg2_chars integer(C_LONG_LONG), dimension(:), target :: value integer(C_LONG_LONG), pointer :: farg3_view - type(SwigClassWrapper) :: farg1 type(SwigArrayWrapper) :: farg2 type(SwigArrayWrapper) :: farg3 @@ -1192,12 +1197,10 @@ subroutine swigf_ParameterList_set__SWIG_8(self, name, value) subroutine swigf_ParameterList_set__SWIG_9(self, name, value) use, intrinsic :: ISO_C_BINDING -class(ParameterList), intent(inout) :: self - +class(ParameterList), intent(in) :: self character(kind=C_CHAR, len=*), target :: name character(kind=C_CHAR), dimension(:), allocatable, target :: farg2_chars class(ParameterList), intent(in) :: value - type(SwigClassWrapper) :: farg1 type(SwigArrayWrapper) :: farg2 type(SwigClassWrapper) :: farg3 @@ -1212,11 +1215,9 @@ function swigf_ParameterList_get_real(self, name) & result(swig_result) use, intrinsic :: ISO_C_BINDING real(C_DOUBLE) :: swig_result -class(ParameterList), intent(inout) :: self - +class(ParameterList), intent(in) :: self character(kind=C_CHAR, len=*), target :: name character(kind=C_CHAR), dimension(:), allocatable, target :: farg2_chars - real(C_DOUBLE) :: fresult type(SwigClassWrapper) :: farg1 type(SwigArrayWrapper) :: farg2 @@ -1231,11 +1232,9 @@ function swigf_ParameterList_get_integer(self, name) & result(swig_result) use, intrinsic :: ISO_C_BINDING integer :: swig_result -class(ParameterList), intent(inout) :: self - +class(ParameterList), intent(in) :: self character(kind=C_CHAR, len=*), target :: name character(kind=C_CHAR), dimension(:), allocatable, target :: farg2_chars - integer(C_INT) :: fresult type(SwigClassWrapper) :: farg1 type(SwigArrayWrapper) :: farg2 @@ -1250,11 +1249,9 @@ function swigf_ParameterList_get_longlong(self, name) & result(swig_result) use, intrinsic :: ISO_C_BINDING integer(C_LONG_LONG) :: swig_result -class(ParameterList), intent(inout) :: self - +class(ParameterList), intent(in) :: self character(kind=C_CHAR, len=*), target :: name character(kind=C_CHAR), dimension(:), allocatable, target :: farg2_chars - integer(C_LONG_LONG) :: fresult type(SwigClassWrapper) :: farg1 type(SwigArrayWrapper) :: farg2 @@ -1269,11 +1266,9 @@ function swigf_ParameterList_get_logical(self, name) & result(swig_result) use, intrinsic :: ISO_C_BINDING logical :: swig_result -class(ParameterList), intent(inout) :: self - +class(ParameterList), intent(in) :: self character(kind=C_CHAR, len=*), target :: name character(kind=C_CHAR), dimension(:), allocatable, target :: farg2_chars - integer(C_INT) :: fresult type(SwigClassWrapper) :: farg1 type(SwigArrayWrapper) :: farg2 @@ -1302,11 +1297,9 @@ function swigf_ParameterList_get_string(self, name) & result(swig_result) use, intrinsic :: ISO_C_BINDING character(kind=C_CHAR, len=:), allocatable :: swig_result -class(ParameterList), intent(inout) :: self - +class(ParameterList), intent(in) :: self character(kind=C_CHAR, len=*), target :: name character(kind=C_CHAR), dimension(:), allocatable, target :: farg2_chars - type(SwigArrayWrapper) :: fresult type(SwigClassWrapper) :: farg1 type(SwigArrayWrapper) :: farg2 @@ -1321,11 +1314,9 @@ function swigf_ParameterList_get_arr_real(self, name) & result(swig_result) use, intrinsic :: ISO_C_BINDING real(C_DOUBLE), dimension(:), pointer :: swig_result -class(ParameterList), intent(inout) :: self - +class(ParameterList), intent(in) :: self character(kind=C_CHAR, len=*), target :: name character(kind=C_CHAR), dimension(:), allocatable, target :: farg2_chars - type(SwigArrayWrapper) :: fresult type(SwigClassWrapper) :: farg1 type(SwigArrayWrapper) :: farg2 @@ -1344,11 +1335,9 @@ function swigf_ParameterList_get_arr_integer(self, name) & result(swig_result) use, intrinsic :: ISO_C_BINDING integer(C_INT), dimension(:), pointer :: swig_result -class(ParameterList), intent(inout) :: self - +class(ParameterList), intent(in) :: self character(kind=C_CHAR, len=*), target :: name character(kind=C_CHAR), dimension(:), allocatable, target :: farg2_chars - type(SwigArrayWrapper) :: fresult type(SwigClassWrapper) :: farg1 type(SwigArrayWrapper) :: farg2 @@ -1367,11 +1356,9 @@ function swigf_ParameterList_get_arr_longlong(self, name) & result(swig_result) use, intrinsic :: ISO_C_BINDING integer(C_LONG_LONG), dimension(:), pointer :: swig_result -class(ParameterList), intent(inout) :: self - +class(ParameterList), intent(in) :: self character(kind=C_CHAR, len=*), target :: name character(kind=C_CHAR), dimension(:), allocatable, target :: farg2_chars - type(SwigArrayWrapper) :: fresult type(SwigClassWrapper) :: farg1 type(SwigArrayWrapper) :: farg2 @@ -1389,7 +1376,6 @@ function swigf_ParameterList_get_arr_longlong(self, name) & subroutine delete_ParameterList(self) use, intrinsic :: ISO_C_BINDING class(ParameterList), intent(inout) :: self - type(SwigClassWrapper) :: farg1 farg1 = self%swigdata @@ -1400,19 +1386,24 @@ subroutine delete_ParameterList(self) self%swigdata%mem = SWIG_NULL end subroutine - subroutine swigf_assignment_ParameterList(self, other) - use, intrinsic :: ISO_C_BINDING - class(ParameterList), intent(inout) :: self - type(ParameterList), intent(in) :: other - call swigc_assignment_ParameterList(self%swigdata, other%swigdata) - end subroutine +subroutine swigf_ParameterList_op_assign__(self, other) +use, intrinsic :: ISO_C_BINDING +class(ParameterList), intent(inout) :: self +type(ParameterList), intent(in) :: other +type(SwigClassWrapper) :: farg1 +type(SwigClassWrapper) :: farg2 + +farg1 = self%swigdata +farg2 = other%swigdata +call swigc_ParameterList_op_assign__(farg1, farg2) +self%swigdata = farg1 +end subroutine + subroutine load_from_xml(plist, xml_path) use, intrinsic :: ISO_C_BINDING class(ParameterList), intent(in) :: plist - character(kind=C_CHAR, len=*), target :: xml_path character(kind=C_CHAR), dimension(:), allocatable, target :: farg2_chars - type(SwigClassWrapper) :: farg1 type(SwigArrayWrapper) :: farg2 @@ -1424,10 +1415,8 @@ subroutine load_from_xml(plist, xml_path) subroutine save_to_xml(plist, xml_path) use, intrinsic :: ISO_C_BINDING class(ParameterList), intent(in) :: plist - character(kind=C_CHAR, len=*), target :: xml_path character(kind=C_CHAR), dimension(:), allocatable, target :: farg2_chars - type(SwigClassWrapper) :: farg1 type(SwigArrayWrapper) :: farg2 diff --git a/src/teuchos/src/swig/forteuchosFORTRAN_wrap.cxx b/src/teuchos/src/swig/forteuchosFORTRAN_wrap.cxx index 44ce2891..2412912e 100644 --- a/src/teuchos/src/swig/forteuchosFORTRAN_wrap.cxx +++ b/src/teuchos/src/swig/forteuchosFORTRAN_wrap.cxx @@ -243,7 +243,7 @@ struct assignment_flags; #define SWIG_assign(LEFTTYPE, LEFT, RIGHTTYPE, RIGHT, FLAGS) \ - SWIG_assign_impl::value >(LEFT, RIGHT); + SWIG_assign_impl::value >(LEFT, RIGHT); #define SWIG_check_sp_nonnull(INPUT, TYPENAME, FNAME, FUNCNAME, RETURNNULL) \ @@ -482,7 +482,7 @@ struct AssignmentTraits { template -SWIGINTERN void SWIG_assign_impl(SwigClassWrapper* self, SwigClassWrapper* other) { +SWIGINTERN void SWIG_assign_impl(SwigClassWrapper* self, const SwigClassWrapper* other) { typedef swig::AssignmentTraits Traits_t; T1* pself = static_cast(self->cptr); T2* pother = static_cast(other->cptr); @@ -495,9 +495,7 @@ SWIGINTERN void SWIG_assign_impl(SwigClassWrapper* self, SwigClassWrapper* other break; case SWIG_MOVE: /* capture pointer from RHS */ self->cptr = other->cptr; - other->cptr = NULL; self->mem = SWIG_OWN; - other->mem = SWIG_NULL; break; case SWIG_OWN: /* copy from RHS */ self->cptr = Traits_t::copy_construct(pother); @@ -523,8 +521,6 @@ SWIGINTERN void SWIG_assign_impl(SwigClassWrapper* self, SwigClassWrapper* other /* Move RHS into LHS; delete RHS */ Traits_t::move_assign(pself, pother); Traits_t::destruct(pother); - other->cptr = NULL; - other->mem = SWIG_NULL; break; case SWIG_OWN: case SWIG_REF: @@ -552,8 +548,6 @@ SWIGINTERN void SWIG_assign_impl(SwigClassWrapper* self, SwigClassWrapper* other * same. */ Traits_t::move_assign(pself, pother); Traits_t::destruct(pother); - other->cptr = NULL; - other->mem = SWIG_NULL; break; case SWIG_OWN: case SWIG_REF: @@ -717,11 +711,10 @@ SWIGEXPORT SwigArrayWrapper _wrap_TeuchosArrayInt_view(SwigClassWrapper const *f } -SWIGEXPORT void _wrap_delete_TeuchosArrayInt(SwigClassWrapper const *farg1) { +SWIGEXPORT void _wrap_delete_TeuchosArrayInt(SwigClassWrapper *farg1) { Teuchos::Array< int > *arg1 = (Teuchos::Array< int > *) 0 ; - SWIG_check_mutable_nonnull(*farg1, "Teuchos::Array< int > *", "TeuchosArrayInt", "Teuchos::Array< int >::~Array()", return ); - arg1 = static_cast< Teuchos::Array< int > * >(farg1->cptr); + (void)sizeof(farg1); { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Teuchos::Array< int >::~Array()");; @@ -745,15 +738,39 @@ SWIGEXPORT void _wrap_delete_TeuchosArrayInt(SwigClassWrapper const *farg1) { SWIG_exception_impl("Teuchos::Array< int >::~Array()", SWIG_UnknownError, "An unknown exception occurred", return ); } } - } -SWIGEXPORT void _wrap_assign_TeuchosArrayInt(SwigClassWrapper * self, SwigClassWrapper const * other) { - typedef Teuchos::Array< int > swig_lhs_classtype; - SWIG_assign(swig_lhs_classtype, self, - swig_lhs_classtype, const_cast(other), - 0 | swig::IS_DESTR | swig::IS_COPY_CONSTR); +SWIGEXPORT void _wrap_TeuchosArrayInt_op_assign__(SwigClassWrapper *farg1, SwigClassWrapper const *farg2) { + Teuchos::Array< int > *arg1 = (Teuchos::Array< int > *) 0 ; + Teuchos::Array< int > *arg2 = 0 ; + + (void)sizeof(arg1); + (void)sizeof(arg2); + { + // Make sure no unhandled exceptions exist before performing a new action + SWIG_check_unhandled_exception_impl("Teuchos::Array< int >::operator =(Teuchos::Array< int > const &)");; + try + { + // Attempt the wrapped function call + typedef Teuchos::Array< int > swig_lhs_classtype; + SWIG_assign(swig_lhs_classtype, farg1, swig_lhs_classtype, farg2, 0 | swig::IS_DESTR | swig::IS_COPY_CONSTR); + } + catch (const std::range_error& e) + { + // Store a C++ exception + SWIG_exception_impl("Teuchos::Array< int >::operator =(Teuchos::Array< int > const &)", SWIG_IndexError, e.what(), return ); + } + catch (const std::exception& e) + { + // Store a C++ exception + SWIG_exception_impl("Teuchos::Array< int >::operator =(Teuchos::Array< int > const &)", SWIG_RuntimeError, e.what(), return ); + } + catch (...) + { + SWIG_exception_impl("Teuchos::Array< int >::operator =(Teuchos::Array< int > const &)", SWIG_UnknownError, "An unknown exception occurred", return ); + } + } } @@ -830,11 +847,10 @@ SWIGEXPORT SwigArrayWrapper _wrap_TeuchosArrayDbl_view(SwigClassWrapper const *f } -SWIGEXPORT void _wrap_delete_TeuchosArrayDbl(SwigClassWrapper const *farg1) { +SWIGEXPORT void _wrap_delete_TeuchosArrayDbl(SwigClassWrapper *farg1) { Teuchos::Array< double > *arg1 = (Teuchos::Array< double > *) 0 ; - SWIG_check_mutable_nonnull(*farg1, "Teuchos::Array< double > *", "TeuchosArrayDbl", "Teuchos::Array< double >::~Array()", return ); - arg1 = static_cast< Teuchos::Array< double > * >(farg1->cptr); + (void)sizeof(farg1); { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Teuchos::Array< double >::~Array()");; @@ -858,15 +874,39 @@ SWIGEXPORT void _wrap_delete_TeuchosArrayDbl(SwigClassWrapper const *farg1) { SWIG_exception_impl("Teuchos::Array< double >::~Array()", SWIG_UnknownError, "An unknown exception occurred", return ); } } - } -SWIGEXPORT void _wrap_assign_TeuchosArrayDbl(SwigClassWrapper * self, SwigClassWrapper const * other) { - typedef Teuchos::Array< double > swig_lhs_classtype; - SWIG_assign(swig_lhs_classtype, self, - swig_lhs_classtype, const_cast(other), - 0 | swig::IS_DESTR | swig::IS_COPY_CONSTR); +SWIGEXPORT void _wrap_TeuchosArrayDbl_op_assign__(SwigClassWrapper *farg1, SwigClassWrapper const *farg2) { + Teuchos::Array< double > *arg1 = (Teuchos::Array< double > *) 0 ; + Teuchos::Array< double > *arg2 = 0 ; + + (void)sizeof(arg1); + (void)sizeof(arg2); + { + // Make sure no unhandled exceptions exist before performing a new action + SWIG_check_unhandled_exception_impl("Teuchos::Array< double >::operator =(Teuchos::Array< double > const &)");; + try + { + // Attempt the wrapped function call + typedef Teuchos::Array< double > swig_lhs_classtype; + SWIG_assign(swig_lhs_classtype, farg1, swig_lhs_classtype, farg2, 0 | swig::IS_DESTR | swig::IS_COPY_CONSTR); + } + catch (const std::range_error& e) + { + // Store a C++ exception + SWIG_exception_impl("Teuchos::Array< double >::operator =(Teuchos::Array< double > const &)", SWIG_IndexError, e.what(), return ); + } + catch (const std::exception& e) + { + // Store a C++ exception + SWIG_exception_impl("Teuchos::Array< double >::operator =(Teuchos::Array< double > const &)", SWIG_RuntimeError, e.what(), return ); + } + catch (...) + { + SWIG_exception_impl("Teuchos::Array< double >::operator =(Teuchos::Array< double > const &)", SWIG_UnknownError, "An unknown exception occurred", return ); + } + } } @@ -943,11 +983,10 @@ SWIGEXPORT SwigArrayWrapper _wrap_TeuchosArrayLongLong_view(SwigClassWrapper con } -SWIGEXPORT void _wrap_delete_TeuchosArrayLongLong(SwigClassWrapper const *farg1) { +SWIGEXPORT void _wrap_delete_TeuchosArrayLongLong(SwigClassWrapper *farg1) { Teuchos::Array< long long > *arg1 = (Teuchos::Array< long long > *) 0 ; - SWIG_check_mutable_nonnull(*farg1, "Teuchos::Array< long long > *", "TeuchosArrayLongLong", "Teuchos::Array< long long >::~Array()", return ); - arg1 = static_cast< Teuchos::Array< long long > * >(farg1->cptr); + (void)sizeof(farg1); { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Teuchos::Array< long long >::~Array()");; @@ -971,15 +1010,39 @@ SWIGEXPORT void _wrap_delete_TeuchosArrayLongLong(SwigClassWrapper const *farg1) SWIG_exception_impl("Teuchos::Array< long long >::~Array()", SWIG_UnknownError, "An unknown exception occurred", return ); } } - } -SWIGEXPORT void _wrap_assign_TeuchosArrayLongLong(SwigClassWrapper * self, SwigClassWrapper const * other) { - typedef Teuchos::Array< long long > swig_lhs_classtype; - SWIG_assign(swig_lhs_classtype, self, - swig_lhs_classtype, const_cast(other), - 0 | swig::IS_DESTR | swig::IS_COPY_CONSTR); +SWIGEXPORT void _wrap_TeuchosArrayLongLong_op_assign__(SwigClassWrapper *farg1, SwigClassWrapper const *farg2) { + Teuchos::Array< long long > *arg1 = (Teuchos::Array< long long > *) 0 ; + Teuchos::Array< long long > *arg2 = 0 ; + + (void)sizeof(arg1); + (void)sizeof(arg2); + { + // Make sure no unhandled exceptions exist before performing a new action + SWIG_check_unhandled_exception_impl("Teuchos::Array< long long >::operator =(Teuchos::Array< long long > const &)");; + try + { + // Attempt the wrapped function call + typedef Teuchos::Array< long long > swig_lhs_classtype; + SWIG_assign(swig_lhs_classtype, farg1, swig_lhs_classtype, farg2, 0 | swig::IS_DESTR | swig::IS_COPY_CONSTR); + } + catch (const std::range_error& e) + { + // Store a C++ exception + SWIG_exception_impl("Teuchos::Array< long long >::operator =(Teuchos::Array< long long > const &)", SWIG_IndexError, e.what(), return ); + } + catch (const std::exception& e) + { + // Store a C++ exception + SWIG_exception_impl("Teuchos::Array< long long >::operator =(Teuchos::Array< long long > const &)", SWIG_RuntimeError, e.what(), return ); + } + catch (...) + { + SWIG_exception_impl("Teuchos::Array< long long >::operator =(Teuchos::Array< long long > const &)", SWIG_UnknownError, "An unknown exception occurred", return ); + } + } } @@ -1084,7 +1147,6 @@ SWIGEXPORT void _wrap_TeuchosComm_barrier(SwigClassWrapper const *farg1) { SWIG_exception_impl("Teuchos::Comm< int >::barrier() const", SWIG_UnknownError, "An unknown exception occurred", return ); } } - } @@ -1200,7 +1262,7 @@ SWIGEXPORT int _wrap_TeuchosComm_getRawMpiComm(SwigClassWrapper const *farg1) { } -SWIGEXPORT void _wrap_delete_TeuchosComm(SwigClassWrapper const *farg1) { +SWIGEXPORT void _wrap_delete_TeuchosComm(SwigClassWrapper *farg1) { Teuchos::Comm< int > *arg1 = (Teuchos::Comm< int > *) 0 ; Teuchos::RCP< Teuchos::Comm< int > > *smartarg1 ; @@ -1229,15 +1291,41 @@ SWIGEXPORT void _wrap_delete_TeuchosComm(SwigClassWrapper const *farg1) { SWIG_exception_impl("Teuchos::Comm< int >::~Comm()", SWIG_UnknownError, "An unknown exception occurred", return ); } } - } -SWIGEXPORT void _wrap_assign_TeuchosComm(SwigClassWrapper * self, SwigClassWrapper const * other) { - typedef Teuchos::RCP< Teuchos::Comm > swig_lhs_classtype; - SWIG_assign(swig_lhs_classtype, self, - swig_lhs_classtype, const_cast(other), - 0 | swig::IS_DESTR | swig::IS_COPY_CONSTR); +SWIGEXPORT void _wrap_TeuchosComm_op_assign__(SwigClassWrapper *farg1, SwigClassWrapper const *farg2) { + Teuchos::Comm< int > *arg1 = (Teuchos::Comm< int > *) 0 ; + Teuchos::Comm< int > *arg2 = 0 ; + Teuchos::RCP< Teuchos::Comm< int > > *smartarg1 ; + + smartarg1 = static_cast< Teuchos::RCP< Teuchos::Comm >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Teuchos::Comm* >(smartarg1->get()) : NULL; + (void)sizeof(arg2); + { + // Make sure no unhandled exceptions exist before performing a new action + SWIG_check_unhandled_exception_impl("Teuchos::Comm< int >::operator =(Teuchos::Comm< int > const &)");; + try + { + // Attempt the wrapped function call + typedef Teuchos::RCP< Teuchos::Comm > swig_lhs_classtype; + SWIG_assign(swig_lhs_classtype, farg1, swig_lhs_classtype, farg2, 0 | swig::IS_DESTR | swig::IS_COPY_CONSTR); + } + catch (const std::range_error& e) + { + // Store a C++ exception + SWIG_exception_impl("Teuchos::Comm< int >::operator =(Teuchos::Comm< int > const &)", SWIG_IndexError, e.what(), return ); + } + catch (const std::exception& e) + { + // Store a C++ exception + SWIG_exception_impl("Teuchos::Comm< int >::operator =(Teuchos::Comm< int > const &)", SWIG_RuntimeError, e.what(), return ); + } + catch (...) + { + SWIG_exception_impl("Teuchos::Comm< int >::operator =(Teuchos::Comm< int > const &)", SWIG_UnknownError, "An unknown exception occurred", return ); + } + } } @@ -1340,7 +1428,6 @@ SWIGEXPORT void _wrap_ParameterList_print(SwigClassWrapper const *farg1) { SWIG_exception_impl("Teuchos::ParameterList::print() const", SWIG_UnknownError, "An unknown exception occurred", return ); } } - } @@ -1377,7 +1464,6 @@ SWIGEXPORT void _wrap_ParameterList_remove(SwigClassWrapper const *farg1, SwigAr SWIG_exception_impl("Teuchos::ParameterList::remove(std::string const &)", SWIG_UnknownError, "An unknown exception occurred", return ); } } - } @@ -1501,7 +1587,6 @@ SWIGEXPORT void _wrap_ParameterList_set__SWIG_1(SwigClassWrapper const *farg1, S SWIG_exception_impl("Teuchos::ParameterList::set< double >(std::string const &,double const &)", SWIG_UnknownError, "An unknown exception occurred", return ); } } - } @@ -1542,7 +1627,6 @@ SWIGEXPORT void _wrap_ParameterList_set__SWIG_2(SwigClassWrapper const *farg1, S SWIG_exception_impl("Teuchos::ParameterList::set< int >(std::string const &,int const &)", SWIG_UnknownError, "An unknown exception occurred", return ); } } - } @@ -1583,7 +1667,6 @@ SWIGEXPORT void _wrap_ParameterList_set__SWIG_3(SwigClassWrapper const *farg1, S SWIG_exception_impl("Teuchos::ParameterList::set< long long >(std::string const &,long long const &)", SWIG_UnknownError, "An unknown exception occurred", return ); } } - } @@ -1624,7 +1707,6 @@ SWIGEXPORT void _wrap_ParameterList_set__SWIG_4(SwigClassWrapper const *farg1, S SWIG_exception_impl("Teuchos::ParameterList::set< bool >(std::string const &,bool const &)", SWIG_UnknownError, "An unknown exception occurred", return ); } } - } @@ -1665,7 +1747,6 @@ SWIGEXPORT void _wrap_ParameterList_set__SWIG_5(SwigClassWrapper const *farg1, S SWIG_exception_impl("Teuchos::ParameterList::set< std::string >(std::string const &,std::string const &)", SWIG_UnknownError, "An unknown exception occurred", return ); } } - } @@ -1708,7 +1789,6 @@ SWIGEXPORT void _wrap_ParameterList_set__SWIG_6(SwigClassWrapper const *farg1, S SWIG_exception_impl("Teuchos::ParameterList::set< Teuchos::Array< double > >(std::string const &,Teuchos::Array< double > const &)", SWIG_UnknownError, "An unknown exception occurred", return ); } } - } @@ -1751,7 +1831,6 @@ SWIGEXPORT void _wrap_ParameterList_set__SWIG_7(SwigClassWrapper const *farg1, S SWIG_exception_impl("Teuchos::ParameterList::set< Teuchos::Array< int > >(std::string const &,Teuchos::Array< int > const &)", SWIG_UnknownError, "An unknown exception occurred", return ); } } - } @@ -1794,7 +1873,6 @@ SWIGEXPORT void _wrap_ParameterList_set__SWIG_8(SwigClassWrapper const *farg1, S SWIG_exception_impl("Teuchos::ParameterList::set< Teuchos::Array< long long > >(std::string const &,Teuchos::Array< long long > const &)", SWIG_UnknownError, "An unknown exception occurred", return ); } } - } @@ -1836,7 +1914,6 @@ SWIGEXPORT void _wrap_ParameterList_set__SWIG_9(SwigClassWrapper const *farg1, S SWIG_exception_impl("Teuchos::ParameterList::set< Teuchos::ParameterList >(std::string const &,Teuchos::ParameterList const &)", SWIG_UnknownError, "An unknown exception occurred", return ); } } - } @@ -2164,7 +2241,7 @@ SWIGEXPORT SwigArrayWrapper _wrap_ParameterList_get_arr_longlong(SwigClassWrappe } -SWIGEXPORT void _wrap_delete_ParameterList(SwigClassWrapper const *farg1) { +SWIGEXPORT void _wrap_delete_ParameterList(SwigClassWrapper *farg1) { Teuchos::ParameterList *arg1 = (Teuchos::ParameterList *) 0 ; Teuchos::RCP< Teuchos::ParameterList > *smartarg1 ; @@ -2193,15 +2270,44 @@ SWIGEXPORT void _wrap_delete_ParameterList(SwigClassWrapper const *farg1) { SWIG_exception_impl("Teuchos::ParameterList::~ParameterList()", SWIG_UnknownError, "An unknown exception occurred", return ); } } - } -SWIGEXPORT void _wrap_assign_ParameterList(SwigClassWrapper * self, SwigClassWrapper const * other) { - typedef Teuchos::RCP< Teuchos::ParameterList > swig_lhs_classtype; - SWIG_assign(swig_lhs_classtype, self, - swig_lhs_classtype, const_cast(other), - 0 | swig::IS_DESTR | swig::IS_COPY_CONSTR); +SWIGEXPORT void _wrap_ParameterList_op_assign__(SwigClassWrapper *farg1, SwigClassWrapper const *farg2) { + Teuchos::ParameterList *arg1 = (Teuchos::ParameterList *) 0 ; + Teuchos::ParameterList *arg2 = 0 ; + Teuchos::RCP< Teuchos::ParameterList > *smartarg1 ; + Teuchos::RCP< Teuchos::ParameterList const > *smartarg2 ; + + smartarg1 = static_cast< Teuchos::RCP< Teuchos::ParameterList >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Teuchos::ParameterList* >(smartarg1->get()) : NULL; + SWIG_check_sp_nonnull(farg2, "Teuchos::ParameterList *", "ParameterList", "Teuchos::ParameterList::operator =(Teuchos::ParameterList const &)", return ) + smartarg2 = static_cast< Teuchos::RCP* >(farg2->cptr); + arg2 = const_cast< Teuchos::ParameterList* >(smartarg2->get()); + { + // Make sure no unhandled exceptions exist before performing a new action + SWIG_check_unhandled_exception_impl("Teuchos::ParameterList::operator =(Teuchos::ParameterList const &)");; + try + { + // Attempt the wrapped function call + typedef Teuchos::RCP< Teuchos::ParameterList > swig_lhs_classtype; + SWIG_assign(swig_lhs_classtype, farg1, swig_lhs_classtype, farg2, 0 | swig::IS_DESTR | swig::IS_COPY_CONSTR); + } + catch (const std::range_error& e) + { + // Store a C++ exception + SWIG_exception_impl("Teuchos::ParameterList::operator =(Teuchos::ParameterList const &)", SWIG_IndexError, e.what(), return ); + } + catch (const std::exception& e) + { + // Store a C++ exception + SWIG_exception_impl("Teuchos::ParameterList::operator =(Teuchos::ParameterList const &)", SWIG_RuntimeError, e.what(), return ); + } + catch (...) + { + SWIG_exception_impl("Teuchos::ParameterList::operator =(Teuchos::ParameterList const &)", SWIG_UnknownError, "An unknown exception occurred", return ); + } + } } @@ -2237,7 +2343,6 @@ SWIGEXPORT void _wrap_load_from_xml(SwigClassWrapper const *farg1, SwigArrayWrap SWIG_exception_impl("load_from_xml(Teuchos::RCP< Teuchos::ParameterList > const &,std::string const &)", SWIG_UnknownError, "An unknown exception occurred", return ); } } - } @@ -2275,7 +2380,6 @@ SWIGEXPORT void _wrap_save_to_xml(SwigClassWrapper const *farg1, SwigArrayWrappe SWIG_exception_impl("save_to_xml(Teuchos::ParameterList const &,std::string const &)", SWIG_UnknownError, "An unknown exception occurred", return ); } } - } diff --git a/src/tpetra/src/swig/fortpetra.F90 b/src/tpetra/src/swig/fortpetra.F90 index f8cfbe03..7852f6ef 100644 --- a/src/tpetra/src/swig/fortpetra.F90 +++ b/src/tpetra/src/swig/fortpetra.F90 @@ -116,6 +116,9 @@ module fortpetra type, public :: SWIGTYPE_Teuchos__RCPT_Kokkos__Compat__KokkosSerialWrapper9ZCDM type(SwigClassWrapper), public :: swigdata end type + type, public :: SWIGTYPE_Tpetra__MapT_LO_GO_NO_t + type(SwigClassWrapper), public :: swigdata + end type ! class Tpetra::Map< LO,GO,NO > type, public :: TpetraMap type(SwigClassWrapper), public :: swigdata @@ -132,8 +135,8 @@ module fortpetra procedure :: getMaxAllGlobalIndex => swigf_TpetraMap_getMaxAllGlobalIndex procedure :: getLocalElement => swigf_TpetraMap_getLocalElement procedure :: getGlobalElement => swigf_TpetraMap_getGlobalElement - procedure, private :: getRemoteIndexList__SWIG_0 => swigf_TpetraMap_getRemoteIndexList__SWIG_0 - procedure, private :: getRemoteIndexList__SWIG_1 => swigf_TpetraMap_getRemoteIndexList__SWIG_1 + procedure, private :: swigf_TpetraMap_getRemoteIndexList__SWIG_0 + procedure, private :: swigf_TpetraMap_getRemoteIndexList__SWIG_1 procedure :: getNodeElementList => swigf_TpetraMap_getNodeElementList procedure :: isNodeLocalElement => swigf_TpetraMap_isNodeLocalElement procedure :: isNodeGlobalElement => swigf_TpetraMap_isNodeGlobalElement @@ -148,23 +151,26 @@ module fortpetra procedure :: description => swigf_TpetraMap_description procedure :: removeEmptyProcesses => swigf_TpetraMap_removeEmptyProcesses procedure :: replaceCommWithSubset => swigf_TpetraMap_replaceCommWithSubset - procedure, private :: swigf_assignment_TpetraMap - generic :: assignment(=) => swigf_assignment_TpetraMap - generic :: getRemoteIndexList => getRemoteIndexList__SWIG_0, getRemoteIndexList__SWIG_1 + procedure, private :: swigf_TpetraMap_op_assign__ + generic :: assignment(=) => swigf_TpetraMap_op_assign__ + generic :: getRemoteIndexList => swigf_TpetraMap_getRemoteIndexList__SWIG_0, swigf_TpetraMap_getRemoteIndexList__SWIG_1 end type TpetraMap interface TpetraMap - module procedure new_TpetraMap__SWIG_0 - module procedure new_TpetraMap__SWIG_1 - module procedure new_TpetraMap__SWIG_2 - module procedure new_TpetraMap__SWIG_3 - module procedure new_TpetraMap__SWIG_4 - module procedure new_TpetraMap__SWIG_5 - module procedure new_TpetraMap__SWIG_6 - module procedure new_TpetraMap__SWIG_7 + module procedure swigf_new_TpetraMap__SWIG_0 + module procedure swigf_new_TpetraMap__SWIG_1 + module procedure swigf_new_TpetraMap__SWIG_2 + module procedure swigf_new_TpetraMap__SWIG_3 + module procedure swigf_new_TpetraMap__SWIG_4 + module procedure swigf_new_TpetraMap__SWIG_5 + module procedure swigf_new_TpetraMap__SWIG_6 + module procedure swigf_new_TpetraMap__SWIG_7 end interface type, public :: SWIGTYPE_std__ostream type(SwigClassWrapper), public :: swigdata end type + type, public :: SWIGTYPE_Tpetra__ImportT_LO_GO_NO_t + type(SwigClassWrapper), public :: swigdata + end type ! class Tpetra::Import< LO,GO,NO > type, public :: TpetraImport type(SwigClassWrapper), public :: swigdata @@ -178,20 +184,23 @@ module fortpetra procedure :: getSourceMap => swigf_TpetraImport_getSourceMap procedure :: getTargetMap => swigf_TpetraImport_getTargetMap procedure :: isLocallyComplete => swigf_TpetraImport_isLocallyComplete - procedure, private :: setUnion__SWIG_0 => swigf_TpetraImport_setUnion__SWIG_0 - procedure, private :: setUnion__SWIG_1 => swigf_TpetraImport_setUnion__SWIG_1 + procedure, private :: swigf_TpetraImport_setUnion__SWIG_0 + procedure, private :: swigf_TpetraImport_setUnion__SWIG_1 procedure :: createRemoteOnlyImport => swigf_TpetraImport_createRemoteOnlyImport procedure :: print => swigf_TpetraImport_print - procedure, private :: swigf_assignment_TpetraImport - generic :: assignment(=) => swigf_assignment_TpetraImport - generic :: setUnion => setUnion__SWIG_0, setUnion__SWIG_1 + procedure, private :: swigf_TpetraImport_op_assign__ + generic :: assignment(=) => swigf_TpetraImport_op_assign__ + generic :: setUnion => swigf_TpetraImport_setUnion__SWIG_0, swigf_TpetraImport_setUnion__SWIG_1 end type TpetraImport interface TpetraImport - module procedure new_TpetraImport__SWIG_0 - module procedure new_TpetraImport__SWIG_1 - module procedure new_TpetraImport__SWIG_2 - module procedure new_TpetraImport__SWIG_3 + module procedure swigf_new_TpetraImport__SWIG_0 + module procedure swigf_new_TpetraImport__SWIG_1 + module procedure swigf_new_TpetraImport__SWIG_2 + module procedure swigf_new_TpetraImport__SWIG_3 end interface + type, public :: SWIGTYPE_Tpetra__ExportT_LO_GO_NO_t + type(SwigClassWrapper), public :: swigdata + end type ! class Tpetra::Export< LO,GO,NO > type, public :: TpetraExport type(SwigClassWrapper), public :: swigdata @@ -206,18 +215,21 @@ module fortpetra procedure :: getTargetMap => swigf_TpetraExport_getTargetMap procedure :: isLocallyComplete => swigf_TpetraExport_isLocallyComplete procedure :: print => swigf_TpetraExport_print - procedure, private :: swigf_assignment_TpetraExport - generic :: assignment(=) => swigf_assignment_TpetraExport + procedure, private :: swigf_TpetraExport_op_assign__ + generic :: assignment(=) => swigf_TpetraExport_op_assign__ end type TpetraExport interface TpetraExport - module procedure new_TpetraExport__SWIG_0 - module procedure new_TpetraExport__SWIG_1 - module procedure new_TpetraExport__SWIG_2 - module procedure new_TpetraExport__SWIG_3 + module procedure swigf_new_TpetraExport__SWIG_0 + module procedure swigf_new_TpetraExport__SWIG_1 + module procedure swigf_new_TpetraExport__SWIG_2 + module procedure swigf_new_TpetraExport__SWIG_3 end interface type, public :: SWIGTYPE_Kokkos__ViewT_double_p_Kokkos__HostSpace_t type(SwigClassWrapper), public :: swigdata end type + type, public :: SWIGTYPE_Tpetra__MultiVectorT_SC_LO_GO_NO_t + type(SwigClassWrapper), public :: swigdata + end type ! class Tpetra::MultiVector< SC,LO,GO,NO > type, public :: TpetraMultiVector type(SwigClassWrapper), public :: swigdata @@ -225,14 +237,14 @@ module fortpetra procedure :: swap => swigf_TpetraMultiVector_swap procedure :: release => delete_TpetraMultiVector procedure :: replaceGlobalValue => swigf_TpetraMultiVector_replaceGlobalValue - procedure, private :: sumIntoGlobalValue__SWIG_0 => swigf_TpetraMultiVector_sumIntoGlobalValue__SWIG_0 - procedure, private :: sumIntoGlobalValue__SWIG_1 => swigf_TpetraMultiVector_sumIntoGlobalValue__SWIG_1 + procedure, private :: swigf_TpetraMultiVector_sumIntoGlobalValue__SWIG_0 + procedure, private :: swigf_TpetraMultiVector_sumIntoGlobalValue__SWIG_1 procedure :: replaceLocalValue => swigf_TpetraMultiVector_replaceLocalValue - procedure, private :: sumIntoLocalValue__SWIG_0 => swigf_TpetraMultiVector_sumIntoLocalValue__SWIG_0 - procedure, private :: sumIntoLocalValue__SWIG_1 => swigf_TpetraMultiVector_sumIntoLocalValue__SWIG_1 + procedure, private :: swigf_TpetraMultiVector_sumIntoLocalValue__SWIG_0 + procedure, private :: swigf_TpetraMultiVector_sumIntoLocalValue__SWIG_1 procedure :: putScalar => swigf_TpetraMultiVector_putScalar - procedure, private :: randomize__SWIG_0 => swigf_TpetraMultiVector_randomize__SWIG_0 - procedure, private :: randomize__SWIG_1 => swigf_TpetraMultiVector_randomize__SWIG_1 + procedure, private :: swigf_TpetraMultiVector_randomize__SWIG_0 + procedure, private :: swigf_TpetraMultiVector_randomize__SWIG_1 procedure :: replaceMap => swigf_TpetraMultiVector_replaceMap procedure :: reduce => swigf_TpetraMultiVector_reduce procedure :: subCopy => swigf_TpetraMultiVector_subCopy @@ -251,21 +263,21 @@ module fortpetra procedure :: need_sync_device => swigf_TpetraMultiVector_need_sync_device procedure :: modify_device => swigf_TpetraMultiVector_modify_device procedure :: modify_host => swigf_TpetraMultiVector_modify_host - procedure, private :: dot__SWIG_0 => swigf_TpetraMultiVector_dot__SWIG_0 - procedure, private :: dot__SWIG_3 => swigf_TpetraMultiVector_dot__SWIG_3 + procedure, private :: swigf_TpetraMultiVector_dot__SWIG_0 + procedure, private :: swigf_TpetraMultiVector_dot__SWIG_3 procedure :: abs => swigf_TpetraMultiVector_abs procedure :: reciprocal => swigf_TpetraMultiVector_reciprocal - procedure, private :: scale__SWIG_0 => swigf_TpetraMultiVector_scale__SWIG_0 - procedure, private :: scale__SWIG_1 => swigf_TpetraMultiVector_scale__SWIG_1 - procedure, private :: scale__SWIG_2 => swigf_TpetraMultiVector_scale__SWIG_2 - procedure, private :: update__SWIG_0 => swigf_TpetraMultiVector_update__SWIG_0 - procedure, private :: update__SWIG_1 => swigf_TpetraMultiVector_update__SWIG_1 - procedure, private :: norm1__SWIG_1 => swigf_TpetraMultiVector_norm1__SWIG_1 - procedure, private :: norm1__SWIG_3 => swigf_TpetraMultiVector_norm1__SWIG_3 - procedure, private :: norm2__SWIG_1 => swigf_TpetraMultiVector_norm2__SWIG_1 - procedure, private :: norm2__SWIG_3 => swigf_TpetraMultiVector_norm2__SWIG_3 - procedure, private :: normInf__SWIG_1 => swigf_TpetraMultiVector_normInf__SWIG_1 - procedure, private :: normInf__SWIG_3 => swigf_TpetraMultiVector_normInf__SWIG_3 + procedure, private :: swigf_TpetraMultiVector_scale__SWIG_0 + procedure, private :: swigf_TpetraMultiVector_scale__SWIG_1 + procedure, private :: swigf_TpetraMultiVector_scale__SWIG_2 + procedure, private :: swigf_TpetraMultiVector_update__SWIG_0 + procedure, private :: swigf_TpetraMultiVector_update__SWIG_1 + procedure, private :: swigf_TpetraMultiVector_norm1__SWIG_1 + procedure, private :: swigf_TpetraMultiVector_norm1__SWIG_3 + procedure, private :: swigf_TpetraMultiVector_norm2__SWIG_1 + procedure, private :: swigf_TpetraMultiVector_norm2__SWIG_3 + procedure, private :: swigf_TpetraMultiVector_normInf__SWIG_1 + procedure, private :: swigf_TpetraMultiVector_normInf__SWIG_3 procedure :: meanValue => swigf_TpetraMultiVector_meanValue procedure :: multiply => swigf_TpetraMultiVector_multiply procedure :: getNumVectors => swigf_TpetraMultiVector_getNumVectors @@ -278,41 +290,47 @@ module fortpetra procedure :: setCopyOrView => swigf_TpetraMultiVector_setCopyOrView procedure :: getCopyOrView => swigf_TpetraMultiVector_getCopyOrView procedure :: isSameSize => swigf_TpetraMultiVector_isSameSize - procedure, private :: doImport__SWIG_0 => swigf_TpetraMultiVector_doImport__SWIG_0 - procedure, private :: doImport__SWIG_1 => swigf_TpetraMultiVector_doImport__SWIG_1 - procedure, private :: doExport__SWIG_0 => swigf_TpetraMultiVector_doExport__SWIG_0 - procedure, private :: doExport__SWIG_1 => swigf_TpetraMultiVector_doExport__SWIG_1 - procedure, private :: swigf_assignment_TpetraMultiVector - generic :: assignment(=) => swigf_assignment_TpetraMultiVector - generic :: randomize => randomize__SWIG_0, randomize__SWIG_1 - generic :: normInf => normInf__SWIG_1, normInf__SWIG_3 - generic :: doImport => doImport__SWIG_0, doImport__SWIG_1 - generic :: sumIntoGlobalValue => sumIntoGlobalValue__SWIG_0, sumIntoGlobalValue__SWIG_1 - generic :: sumIntoLocalValue => sumIntoLocalValue__SWIG_0, sumIntoLocalValue__SWIG_1 - generic :: dot => dot__SWIG_0, dot__SWIG_3 - generic :: norm1 => norm1__SWIG_1, norm1__SWIG_3 - generic :: doExport => doExport__SWIG_0, doExport__SWIG_1 - generic :: scale => scale__SWIG_0, scale__SWIG_1, scale__SWIG_2 - generic :: norm2 => norm2__SWIG_1, norm2__SWIG_3 - generic :: update => update__SWIG_0, update__SWIG_1 + procedure, private :: swigf_TpetraMultiVector_doImport__SWIG_0 + procedure, private :: swigf_TpetraMultiVector_doImport__SWIG_1 + procedure, private :: swigf_TpetraMultiVector_doExport__SWIG_0 + procedure, private :: swigf_TpetraMultiVector_doExport__SWIG_1 + procedure, private :: swigf_TpetraMultiVector_op_assign__ + generic :: assignment(=) => swigf_TpetraMultiVector_op_assign__ + generic :: randomize => swigf_TpetraMultiVector_randomize__SWIG_0, swigf_TpetraMultiVector_randomize__SWIG_1 + generic :: normInf => swigf_TpetraMultiVector_normInf__SWIG_1, swigf_TpetraMultiVector_normInf__SWIG_3 + generic :: doImport => swigf_TpetraMultiVector_doImport__SWIG_0, swigf_TpetraMultiVector_doImport__SWIG_1 + generic :: sumIntoGlobalValue => swigf_TpetraMultiVector_sumIntoGlobalValue__SWIG_0, & + swigf_TpetraMultiVector_sumIntoGlobalValue__SWIG_1 + generic :: sumIntoLocalValue => swigf_TpetraMultiVector_sumIntoLocalValue__SWIG_0, & + swigf_TpetraMultiVector_sumIntoLocalValue__SWIG_1 + generic :: dot => swigf_TpetraMultiVector_dot__SWIG_0, swigf_TpetraMultiVector_dot__SWIG_3 + generic :: norm1 => swigf_TpetraMultiVector_norm1__SWIG_1, swigf_TpetraMultiVector_norm1__SWIG_3 + generic :: doExport => swigf_TpetraMultiVector_doExport__SWIG_0, swigf_TpetraMultiVector_doExport__SWIG_1 + generic :: scale => swigf_TpetraMultiVector_scale__SWIG_0, swigf_TpetraMultiVector_scale__SWIG_1, & + swigf_TpetraMultiVector_scale__SWIG_2 + generic :: norm2 => swigf_TpetraMultiVector_norm2__SWIG_1, swigf_TpetraMultiVector_norm2__SWIG_3 + generic :: update => swigf_TpetraMultiVector_update__SWIG_0, swigf_TpetraMultiVector_update__SWIG_1 end type TpetraMultiVector interface TpetraMultiVector - module procedure new_TpetraMultiVector__SWIG_0 - module procedure new_TpetraMultiVector__SWIG_1 - module procedure new_TpetraMultiVector__SWIG_2 - module procedure new_TpetraMultiVector__SWIG_3 - module procedure new_TpetraMultiVector__SWIG_4 - module procedure new_TpetraMultiVector__SWIG_5 - module procedure new_TpetraMultiVector__SWIG_7 - module procedure new_TpetraMultiVector__SWIG_8 + module procedure swigf_new_TpetraMultiVector__SWIG_0 + module procedure swigf_new_TpetraMultiVector__SWIG_1 + module procedure swigf_new_TpetraMultiVector__SWIG_2 + module procedure swigf_new_TpetraMultiVector__SWIG_3 + module procedure swigf_new_TpetraMultiVector__SWIG_4 + module procedure swigf_new_TpetraMultiVector__SWIG_5 + module procedure swigf_new_TpetraMultiVector__SWIG_7 + module procedure swigf_new_TpetraMultiVector__SWIG_8 end interface + type, public :: SWIGTYPE_Tpetra__OperatorT_SC_LO_GO_NO_t + type(SwigClassWrapper), public :: swigdata + end type ! class Tpetra::Operator< SC,LO,GO,NO > type, public :: TpetraOperator type(SwigClassWrapper), public :: swigdata contains procedure :: release => delete_TpetraOperator - procedure, private :: swigf_assignment_TpetraOperator - generic :: assignment(=) => swigf_assignment_TpetraOperator + procedure, private :: swigf_TpetraOperator_op_assign__ + generic :: assignment(=) => swigf_TpetraOperator_op_assign__ end type TpetraOperator ! class ForTpetraOperator type, extends(TpetraOperator), public :: ForTpetraOperator @@ -323,8 +341,8 @@ module fortpetra procedure :: getRangeMap => swigf_ForTpetraOperator_getRangeMap procedure :: apply => swigf_ForTpetraOperator_apply procedure :: release => delete_ForTpetraOperator - procedure, private :: swigf_assignment_ForTpetraOperator - generic :: assignment(=) => swigf_assignment_ForTpetraOperator + procedure, private :: swigf_ForTpetraOperator_op_assign__ + generic :: assignment(=) => swigf_ForTpetraOperator_op_assign__ end type ForTpetraOperator interface ForTpetraOperator module procedure new_ForTpetraOperator @@ -341,17 +359,17 @@ module fortpetra type, public :: RowInfo type(SwigClassWrapper), public :: swigdata contains - procedure :: set_localRow => RowInfo_localRow_set - procedure :: get_localRow => RowInfo_localRow_get - procedure :: set_allocSize => RowInfo_allocSize_set - procedure :: get_allocSize => RowInfo_allocSize_get - procedure :: set_numEntries => RowInfo_numEntries_set - procedure :: get_numEntries => RowInfo_numEntries_get - procedure :: set_offset1D => RowInfo_offset1D_set - procedure :: get_offset1D => RowInfo_offset1D_get + procedure :: set_localRow => swigf_RowInfo_localRow_set + procedure :: get_localRow => swigf_RowInfo_localRow_get + procedure :: set_allocSize => swigf_RowInfo_allocSize_set + procedure :: get_allocSize => swigf_RowInfo_allocSize_get + procedure :: set_numEntries => swigf_RowInfo_numEntries_set + procedure :: get_numEntries => swigf_RowInfo_numEntries_get + procedure :: set_offset1D => swigf_RowInfo_offset1D_set + procedure :: get_offset1D => swigf_RowInfo_offset1D_get procedure :: release => delete_RowInfo - procedure, private :: swigf_assignment_RowInfo - generic :: assignment(=) => swigf_assignment_RowInfo + procedure, private :: swigf_RowInfo_op_assign__ + generic :: assignment(=) => swigf_RowInfo_op_assign__ end type RowInfo interface RowInfo module procedure new_RowInfo @@ -363,6 +381,9 @@ module fortpetra end enum integer, parameter, public :: TpetraELocalGlobal = kind(TpetraLocalIndices) public :: TpetraLocalIndices, TpetraGlobalIndices + type, public :: SWIGTYPE_Tpetra__CrsGraphT_LO_GO_NO_t + type(SwigClassWrapper), public :: swigdata + end type ! class Tpetra::CrsGraph< LO,GO,NO > type, public :: TpetraCrsGraph type(SwigClassWrapper), public :: swigdata @@ -372,21 +393,21 @@ module fortpetra procedure :: isIdenticalTo => swigf_TpetraCrsGraph_isIdenticalTo procedure :: setParameterList => swigf_TpetraCrsGraph_setParameterList procedure :: getValidParameters => swigf_TpetraCrsGraph_getValidParameters - procedure, private :: insertGlobalIndices__SWIG_0 => swigf_TpetraCrsGraph_insertGlobalIndices__SWIG_0 - procedure, private :: insertGlobalIndices__SWIG_1 => swigf_TpetraCrsGraph_insertGlobalIndices__SWIG_1 + procedure, private :: swigf_TpetraCrsGraph_insertGlobalIndices__SWIG_0 + procedure, private :: swigf_TpetraCrsGraph_insertGlobalIndices__SWIG_1 procedure :: insertLocalIndices => swigf_TpetraCrsGraph_insertLocalIndices procedure :: removeLocalIndices => swigf_TpetraCrsGraph_removeLocalIndices procedure :: globalAssemble => swigf_TpetraCrsGraph_globalAssemble - procedure, private :: resumeFill__SWIG_0 => swigf_TpetraCrsGraph_resumeFill__SWIG_0 - procedure, private :: resumeFill__SWIG_1 => swigf_TpetraCrsGraph_resumeFill__SWIG_1 - procedure, private :: fillComplete__SWIG_0 => swigf_TpetraCrsGraph_fillComplete__SWIG_0 - procedure, private :: fillComplete__SWIG_1 => swigf_TpetraCrsGraph_fillComplete__SWIG_1 - procedure, private :: fillComplete__SWIG_2 => swigf_TpetraCrsGraph_fillComplete__SWIG_2 - procedure, private :: fillComplete__SWIG_3 => swigf_TpetraCrsGraph_fillComplete__SWIG_3 - procedure, private :: expertStaticFillComplete__SWIG_0 => swigf_TpetraCrsGraph_expertStaticFillComplete__SWIG_0 - procedure, private :: expertStaticFillComplete__SWIG_1 => swigf_TpetraCrsGraph_expertStaticFillComplete__SWIG_1 - procedure, private :: expertStaticFillComplete__SWIG_2 => swigf_TpetraCrsGraph_expertStaticFillComplete__SWIG_2 - procedure, private :: expertStaticFillComplete__SWIG_3 => swigf_TpetraCrsGraph_expertStaticFillComplete__SWIG_3 + procedure, private :: swigf_TpetraCrsGraph_resumeFill__SWIG_0 + procedure, private :: swigf_TpetraCrsGraph_resumeFill__SWIG_1 + procedure, private :: swigf_TpetraCrsGraph_fillComplete__SWIG_0 + procedure, private :: swigf_TpetraCrsGraph_fillComplete__SWIG_1 + procedure, private :: swigf_TpetraCrsGraph_fillComplete__SWIG_2 + procedure, private :: swigf_TpetraCrsGraph_fillComplete__SWIG_3 + procedure, private :: swigf_TpetraCrsGraph_expertStaticFillComplete__SWIG_0 + procedure, private :: swigf_TpetraCrsGraph_expertStaticFillComplete__SWIG_1 + procedure, private :: swigf_TpetraCrsGraph_expertStaticFillComplete__SWIG_2 + procedure, private :: swigf_TpetraCrsGraph_expertStaticFillComplete__SWIG_3 procedure :: getComm => swigf_TpetraCrsGraph_getComm procedure :: getRowMap => swigf_TpetraCrsGraph_getRowMap procedure :: getColMap => swigf_TpetraCrsGraph_getColMap @@ -420,57 +441,62 @@ module fortpetra procedure :: supportsRowViews => swigf_TpetraCrsGraph_supportsRowViews procedure :: description => swigf_TpetraCrsGraph_description procedure :: replaceColMap => swigf_TpetraCrsGraph_replaceColMap - procedure, private :: reindexColumns__SWIG_0 => swigf_TpetraCrsGraph_reindexColumns__SWIG_0 - procedure, private :: reindexColumns__SWIG_1 => swigf_TpetraCrsGraph_reindexColumns__SWIG_1 - procedure, private :: reindexColumns__SWIG_2 => swigf_TpetraCrsGraph_reindexColumns__SWIG_2 + procedure, private :: swigf_TpetraCrsGraph_reindexColumns__SWIG_0 + procedure, private :: swigf_TpetraCrsGraph_reindexColumns__SWIG_1 + procedure, private :: swigf_TpetraCrsGraph_reindexColumns__SWIG_2 procedure :: replaceDomainMapAndImporter => swigf_TpetraCrsGraph_replaceDomainMapAndImporter procedure :: removeEmptyProcessesInPlace => swigf_TpetraCrsGraph_removeEmptyProcessesInPlace - procedure, private :: importAndFillComplete__SWIG_0 => swigf_TpetraCrsGraph_importAndFillComplete__SWIG_0 - procedure, private :: importAndFillComplete__SWIG_1 => swigf_TpetraCrsGraph_importAndFillComplete__SWIG_1 - procedure, private :: importAndFillComplete__SWIG_2 => swigf_TpetraCrsGraph_importAndFillComplete__SWIG_2 - procedure, private :: exportAndFillComplete__SWIG_0 => swigf_TpetraCrsGraph_exportAndFillComplete__SWIG_0 - procedure, private :: exportAndFillComplete__SWIG_1 => swigf_TpetraCrsGraph_exportAndFillComplete__SWIG_1 - procedure, private :: exportAndFillComplete__SWIG_2 => swigf_TpetraCrsGraph_exportAndFillComplete__SWIG_2 - procedure, private :: exportAndFillComplete__SWIG_3 => swigf_TpetraCrsGraph_exportAndFillComplete__SWIG_3 - procedure, private :: exportAndFillComplete__SWIG_4 => swigf_TpetraCrsGraph_exportAndFillComplete__SWIG_4 + procedure, private :: swigf_TpetraCrsGraph_importAndFillComplete__SWIG_0 + procedure, private :: swigf_TpetraCrsGraph_importAndFillComplete__SWIG_1 + procedure, private :: swigf_TpetraCrsGraph_importAndFillComplete__SWIG_2 + procedure, private :: swigf_TpetraCrsGraph_exportAndFillComplete__SWIG_0 + procedure, private :: swigf_TpetraCrsGraph_exportAndFillComplete__SWIG_1 + procedure, private :: swigf_TpetraCrsGraph_exportAndFillComplete__SWIG_2 + procedure, private :: swigf_TpetraCrsGraph_exportAndFillComplete__SWIG_3 + procedure, private :: swigf_TpetraCrsGraph_exportAndFillComplete__SWIG_4 procedure :: haveGlobalConstants => swigf_TpetraCrsGraph_haveGlobalConstants procedure :: computeGlobalConstants => swigf_TpetraCrsGraph_computeGlobalConstants procedure :: getNodeRowPtrs => swigf_TpetraCrsGraph_getNodeRowPtrs procedure :: getNodePackedIndices => swigf_TpetraCrsGraph_getNodePackedIndices - procedure, private :: doImport__SWIG_0 => swigf_TpetraCrsGraph_doImport__SWIG_0 - procedure, private :: doImport__SWIG_1 => swigf_TpetraCrsGraph_doImport__SWIG_1 - procedure, private :: doExport__SWIG_0 => swigf_TpetraCrsGraph_doExport__SWIG_0 - procedure, private :: doExport__SWIG_1 => swigf_TpetraCrsGraph_doExport__SWIG_1 - procedure, private :: swigf_assignment_TpetraCrsGraph - generic :: assignment(=) => swigf_assignment_TpetraCrsGraph - generic :: reindexColumns => reindexColumns__SWIG_0, reindexColumns__SWIG_1, reindexColumns__SWIG_2 - generic :: doImport => doImport__SWIG_0, doImport__SWIG_1 - generic :: insertGlobalIndices => insertGlobalIndices__SWIG_0, insertGlobalIndices__SWIG_1 - generic :: resumeFill => resumeFill__SWIG_0, resumeFill__SWIG_1 - generic :: doExport => doExport__SWIG_0, doExport__SWIG_1 - generic :: fillComplete => fillComplete__SWIG_0, fillComplete__SWIG_1, fillComplete__SWIG_2, fillComplete__SWIG_3 - generic :: expertStaticFillComplete => expertStaticFillComplete__SWIG_0, expertStaticFillComplete__SWIG_1, & - expertStaticFillComplete__SWIG_2, expertStaticFillComplete__SWIG_3 - generic :: importAndFillComplete => importAndFillComplete__SWIG_0, importAndFillComplete__SWIG_1, & - importAndFillComplete__SWIG_2 - generic :: exportAndFillComplete => exportAndFillComplete__SWIG_0, exportAndFillComplete__SWIG_1, & - exportAndFillComplete__SWIG_2, exportAndFillComplete__SWIG_3, exportAndFillComplete__SWIG_4 + procedure, private :: swigf_TpetraCrsGraph_doImport__SWIG_0 + procedure, private :: swigf_TpetraCrsGraph_doImport__SWIG_1 + procedure, private :: swigf_TpetraCrsGraph_doExport__SWIG_0 + procedure, private :: swigf_TpetraCrsGraph_doExport__SWIG_1 + procedure, private :: swigf_TpetraCrsGraph_op_assign__ + generic :: assignment(=) => swigf_TpetraCrsGraph_op_assign__ + generic :: reindexColumns => swigf_TpetraCrsGraph_reindexColumns__SWIG_0, swigf_TpetraCrsGraph_reindexColumns__SWIG_1, & + swigf_TpetraCrsGraph_reindexColumns__SWIG_2 + generic :: doImport => swigf_TpetraCrsGraph_doImport__SWIG_0, swigf_TpetraCrsGraph_doImport__SWIG_1 + generic :: insertGlobalIndices => swigf_TpetraCrsGraph_insertGlobalIndices__SWIG_0, & + swigf_TpetraCrsGraph_insertGlobalIndices__SWIG_1 + generic :: resumeFill => swigf_TpetraCrsGraph_resumeFill__SWIG_0, swigf_TpetraCrsGraph_resumeFill__SWIG_1 + generic :: doExport => swigf_TpetraCrsGraph_doExport__SWIG_0, swigf_TpetraCrsGraph_doExport__SWIG_1 + generic :: fillComplete => swigf_TpetraCrsGraph_fillComplete__SWIG_0, swigf_TpetraCrsGraph_fillComplete__SWIG_1, & + swigf_TpetraCrsGraph_fillComplete__SWIG_2, swigf_TpetraCrsGraph_fillComplete__SWIG_3 + generic :: expertStaticFillComplete => swigf_TpetraCrsGraph_expertStaticFillComplete__SWIG_0, & + swigf_TpetraCrsGraph_expertStaticFillComplete__SWIG_1, swigf_TpetraCrsGraph_expertStaticFillComplete__SWIG_2, & + swigf_TpetraCrsGraph_expertStaticFillComplete__SWIG_3 + generic :: importAndFillComplete => swigf_TpetraCrsGraph_importAndFillComplete__SWIG_0, & + swigf_TpetraCrsGraph_importAndFillComplete__SWIG_1, swigf_TpetraCrsGraph_importAndFillComplete__SWIG_2 + generic :: exportAndFillComplete => swigf_TpetraCrsGraph_exportAndFillComplete__SWIG_0, & + swigf_TpetraCrsGraph_exportAndFillComplete__SWIG_1, swigf_TpetraCrsGraph_exportAndFillComplete__SWIG_2, & + swigf_TpetraCrsGraph_exportAndFillComplete__SWIG_3, swigf_TpetraCrsGraph_exportAndFillComplete__SWIG_4 end type TpetraCrsGraph interface TpetraCrsGraph - module procedure new_TpetraCrsGraph__SWIG_0 - module procedure new_TpetraCrsGraph__SWIG_1 - module procedure new_TpetraCrsGraph__SWIG_2 - module procedure new_TpetraCrsGraph__SWIG_3 - module procedure new_TpetraCrsGraph__SWIG_4 - module procedure new_TpetraCrsGraph__SWIG_5 - module procedure new_TpetraCrsGraph__SWIG_6 - module procedure new_TpetraCrsGraph__SWIG_7 - module procedure new_TpetraCrsGraph__SWIG_8 - module procedure new_TpetraCrsGraph__SWIG_9 - module procedure new_TpetraCrsGraph__SWIG_10 - module procedure new_TpetraCrsGraph__SWIG_11 - module procedure new_TpetraCrsGraph__SWIG_12 - module procedure new_TpetraCrsGraph__SWIG_13 + module procedure swigf_new_TpetraCrsGraph__SWIG_0 + module procedure swigf_new_TpetraCrsGraph__SWIG_1 + module procedure swigf_new_TpetraCrsGraph__SWIG_2 + module procedure swigf_new_TpetraCrsGraph__SWIG_3 + module procedure swigf_new_TpetraCrsGraph__SWIG_4 + module procedure swigf_new_TpetraCrsGraph__SWIG_5 + module procedure swigf_new_TpetraCrsGraph__SWIG_6 + module procedure swigf_new_TpetraCrsGraph__SWIG_7 + module procedure swigf_new_TpetraCrsGraph__SWIG_8 + module procedure swigf_new_TpetraCrsGraph__SWIG_9 + module procedure swigf_new_TpetraCrsGraph__SWIG_10 + module procedure swigf_new_TpetraCrsGraph__SWIG_11 + module procedure swigf_new_TpetraCrsGraph__SWIG_12 + module procedure swigf_new_TpetraCrsGraph__SWIG_13 end interface type, public :: SWIGTYPE_KokkosSparse__CrsMatrixT_Tpetra__CrsMatrixT_doub1E12GN type(SwigClassWrapper), public :: swigdata @@ -478,6 +504,9 @@ module fortpetra type, public :: SWIGTYPE_Teuchos__ArrayRCPT_unsigned_long_t type(SwigClassWrapper), public :: swigdata end type + type, public :: SWIGTYPE_Tpetra__CrsMatrixT_SC_LO_GO_NO_t + type(SwigClassWrapper), public :: swigdata + end type ! class Tpetra::CrsMatrix< SC,LO,GO,NO > type, public :: TpetraCrsMatrix type(SwigClassWrapper), public :: swigdata @@ -486,28 +515,28 @@ module fortpetra procedure :: insertGlobalValues => swigf_TpetraCrsMatrix_insertGlobalValues procedure :: insertLocalValues => swigf_TpetraCrsMatrix_insertLocalValues procedure :: replaceGlobalValues => swigf_TpetraCrsMatrix_replaceGlobalValues - procedure, private :: replaceLocalValues__SWIG_1 => swigf_TpetraCrsMatrix_replaceLocalValues__SWIG_1 - procedure, private :: replaceLocalValues__SWIG_2 => swigf_TpetraCrsMatrix_replaceLocalValues__SWIG_2 - procedure, private :: sumIntoGlobalValues__SWIG_0 => swigf_TpetraCrsMatrix_sumIntoGlobalValues__SWIG_0 - procedure, private :: sumIntoLocalValues__SWIG_0 => swigf_TpetraCrsMatrix_sumIntoLocalValues__SWIG_0 + procedure, private :: swigf_TpetraCrsMatrix_replaceLocalValues__SWIG_1 + procedure, private :: swigf_TpetraCrsMatrix_replaceLocalValues__SWIG_2 + procedure, private :: swigf_TpetraCrsMatrix_sumIntoGlobalValues__SWIG_0 + procedure, private :: swigf_TpetraCrsMatrix_sumIntoLocalValues__SWIG_0 procedure :: setAllToScalar => swigf_TpetraCrsMatrix_setAllToScalar procedure :: scale => swigf_TpetraCrsMatrix_scale procedure :: setAllValues => swigf_TpetraCrsMatrix_setAllValues procedure :: globalAssemble => swigf_TpetraCrsMatrix_globalAssemble - procedure, private :: resumeFill__SWIG_0 => swigf_TpetraCrsMatrix_resumeFill__SWIG_0 - procedure, private :: resumeFill__SWIG_1 => swigf_TpetraCrsMatrix_resumeFill__SWIG_1 - procedure, private :: fillComplete__SWIG_0 => swigf_TpetraCrsMatrix_fillComplete__SWIG_0 - procedure, private :: fillComplete__SWIG_1 => swigf_TpetraCrsMatrix_fillComplete__SWIG_1 - procedure, private :: fillComplete__SWIG_2 => swigf_TpetraCrsMatrix_fillComplete__SWIG_2 - procedure, private :: fillComplete__SWIG_3 => swigf_TpetraCrsMatrix_fillComplete__SWIG_3 - procedure, private :: expertStaticFillComplete__SWIG_0 => swigf_TpetraCrsMatrix_expertStaticFillComplete__SWIG_0 - procedure, private :: expertStaticFillComplete__SWIG_1 => swigf_TpetraCrsMatrix_expertStaticFillComplete__SWIG_1 - procedure, private :: expertStaticFillComplete__SWIG_2 => swigf_TpetraCrsMatrix_expertStaticFillComplete__SWIG_2 - procedure, private :: expertStaticFillComplete__SWIG_3 => swigf_TpetraCrsMatrix_expertStaticFillComplete__SWIG_3 + procedure, private :: swigf_TpetraCrsMatrix_resumeFill__SWIG_0 + procedure, private :: swigf_TpetraCrsMatrix_resumeFill__SWIG_1 + procedure, private :: swigf_TpetraCrsMatrix_fillComplete__SWIG_0 + procedure, private :: swigf_TpetraCrsMatrix_fillComplete__SWIG_1 + procedure, private :: swigf_TpetraCrsMatrix_fillComplete__SWIG_2 + procedure, private :: swigf_TpetraCrsMatrix_fillComplete__SWIG_3 + procedure, private :: swigf_TpetraCrsMatrix_expertStaticFillComplete__SWIG_0 + procedure, private :: swigf_TpetraCrsMatrix_expertStaticFillComplete__SWIG_1 + procedure, private :: swigf_TpetraCrsMatrix_expertStaticFillComplete__SWIG_2 + procedure, private :: swigf_TpetraCrsMatrix_expertStaticFillComplete__SWIG_3 procedure :: replaceColMap => swigf_TpetraCrsMatrix_replaceColMap - procedure, private :: reindexColumns__SWIG_0 => swigf_TpetraCrsMatrix_reindexColumns__SWIG_0 - procedure, private :: reindexColumns__SWIG_1 => swigf_TpetraCrsMatrix_reindexColumns__SWIG_1 - procedure, private :: reindexColumns__SWIG_2 => swigf_TpetraCrsMatrix_reindexColumns__SWIG_2 + procedure, private :: swigf_TpetraCrsMatrix_reindexColumns__SWIG_0 + procedure, private :: swigf_TpetraCrsMatrix_reindexColumns__SWIG_1 + procedure, private :: swigf_TpetraCrsMatrix_reindexColumns__SWIG_2 procedure :: replaceDomainMapAndImporter => swigf_TpetraCrsMatrix_replaceDomainMapAndImporter procedure :: removeEmptyProcessesInPlace => swigf_TpetraCrsMatrix_removeEmptyProcessesInPlace procedure :: getComm => swigf_TpetraCrsMatrix_getComm @@ -538,113 +567,128 @@ module fortpetra procedure :: getLocalRowCopy => swigf_TpetraCrsMatrix_getLocalRowCopy procedure :: getGlobalRowView => swigf_TpetraCrsMatrix_getGlobalRowView procedure :: getLocalDiagOffsets => swigf_TpetraCrsMatrix_getLocalDiagOffsets - procedure, private :: apply__SWIG_0 => swigf_TpetraCrsMatrix_apply__SWIG_0 - procedure, private :: apply__SWIG_1 => swigf_TpetraCrsMatrix_apply__SWIG_1 - procedure, private :: apply__SWIG_2 => swigf_TpetraCrsMatrix_apply__SWIG_2 - procedure, private :: apply__SWIG_3 => swigf_TpetraCrsMatrix_apply__SWIG_3 + procedure, private :: swigf_TpetraCrsMatrix_apply__SWIG_0 + procedure, private :: swigf_TpetraCrsMatrix_apply__SWIG_1 + procedure, private :: swigf_TpetraCrsMatrix_apply__SWIG_2 + procedure, private :: swigf_TpetraCrsMatrix_apply__SWIG_3 procedure :: hasTransposeApply => swigf_TpetraCrsMatrix_hasTransposeApply procedure :: getDomainMap => swigf_TpetraCrsMatrix_getDomainMap procedure :: getRangeMap => swigf_TpetraCrsMatrix_getRangeMap procedure :: gaussSeidel => swigf_TpetraCrsMatrix_gaussSeidel procedure :: gaussSeidelCopy => swigf_TpetraCrsMatrix_gaussSeidelCopy procedure :: description => swigf_TpetraCrsMatrix_description - procedure, private :: importAndFillComplete__SWIG_0 => swigf_TpetraCrsMatrix_importAndFillComplete__SWIG_0 - procedure, private :: importAndFillComplete__SWIG_1 => swigf_TpetraCrsMatrix_importAndFillComplete__SWIG_1 - procedure, private :: importAndFillComplete__SWIG_2 => swigf_TpetraCrsMatrix_importAndFillComplete__SWIG_2 - procedure, private :: exportAndFillComplete__SWIG_0 => swigf_TpetraCrsMatrix_exportAndFillComplete__SWIG_0 - procedure, private :: exportAndFillComplete__SWIG_1 => swigf_TpetraCrsMatrix_exportAndFillComplete__SWIG_1 - procedure, private :: exportAndFillComplete__SWIG_2 => swigf_TpetraCrsMatrix_exportAndFillComplete__SWIG_2 - procedure, private :: exportAndFillComplete__SWIG_3 => swigf_TpetraCrsMatrix_exportAndFillComplete__SWIG_3 - procedure, private :: exportAndFillComplete__SWIG_4 => swigf_TpetraCrsMatrix_exportAndFillComplete__SWIG_4 + procedure, private :: swigf_TpetraCrsMatrix_importAndFillComplete__SWIG_0 + procedure, private :: swigf_TpetraCrsMatrix_importAndFillComplete__SWIG_1 + procedure, private :: swigf_TpetraCrsMatrix_importAndFillComplete__SWIG_2 + procedure, private :: swigf_TpetraCrsMatrix_exportAndFillComplete__SWIG_0 + procedure, private :: swigf_TpetraCrsMatrix_exportAndFillComplete__SWIG_1 + procedure, private :: swigf_TpetraCrsMatrix_exportAndFillComplete__SWIG_2 + procedure, private :: swigf_TpetraCrsMatrix_exportAndFillComplete__SWIG_3 + procedure, private :: swigf_TpetraCrsMatrix_exportAndFillComplete__SWIG_4 procedure :: computeGlobalConstants => swigf_TpetraCrsMatrix_computeGlobalConstants procedure :: haveGlobalConstants => swigf_TpetraCrsMatrix_haveGlobalConstants procedure :: getAllValues => swigf_TpetraCrsMatrix_getAllValues - procedure, private :: swigf_assignment_TpetraCrsMatrix - generic :: assignment(=) => swigf_assignment_TpetraCrsMatrix - generic :: reindexColumns => reindexColumns__SWIG_0, reindexColumns__SWIG_1, reindexColumns__SWIG_2 - generic :: apply => apply__SWIG_0, apply__SWIG_1, apply__SWIG_2, apply__SWIG_3 - generic :: resumeFill => resumeFill__SWIG_0, resumeFill__SWIG_1 - generic :: replaceLocalValues => replaceLocalValues__SWIG_1, replaceLocalValues__SWIG_2 - generic :: sumIntoGlobalValues => sumIntoGlobalValues__SWIG_0 - generic :: sumIntoLocalValues => sumIntoLocalValues__SWIG_0 - generic :: fillComplete => fillComplete__SWIG_0, fillComplete__SWIG_1, fillComplete__SWIG_2, fillComplete__SWIG_3 - generic :: expertStaticFillComplete => expertStaticFillComplete__SWIG_0, expertStaticFillComplete__SWIG_1, & - expertStaticFillComplete__SWIG_2, expertStaticFillComplete__SWIG_3 - generic :: importAndFillComplete => importAndFillComplete__SWIG_0, importAndFillComplete__SWIG_1, & - importAndFillComplete__SWIG_2 - generic :: exportAndFillComplete => exportAndFillComplete__SWIG_0, exportAndFillComplete__SWIG_1, & - exportAndFillComplete__SWIG_2, exportAndFillComplete__SWIG_3, exportAndFillComplete__SWIG_4 + procedure, private :: swigf_TpetraCrsMatrix_op_assign__ + generic :: assignment(=) => swigf_TpetraCrsMatrix_op_assign__ + generic :: reindexColumns => swigf_TpetraCrsMatrix_reindexColumns__SWIG_0, swigf_TpetraCrsMatrix_reindexColumns__SWIG_1, & + swigf_TpetraCrsMatrix_reindexColumns__SWIG_2 + generic :: apply => swigf_TpetraCrsMatrix_apply__SWIG_0, swigf_TpetraCrsMatrix_apply__SWIG_1, & + swigf_TpetraCrsMatrix_apply__SWIG_2, swigf_TpetraCrsMatrix_apply__SWIG_3 + generic :: resumeFill => swigf_TpetraCrsMatrix_resumeFill__SWIG_0, swigf_TpetraCrsMatrix_resumeFill__SWIG_1 + generic :: replaceLocalValues => swigf_TpetraCrsMatrix_replaceLocalValues__SWIG_1, & + swigf_TpetraCrsMatrix_replaceLocalValues__SWIG_2 + generic :: sumIntoGlobalValues => swigf_TpetraCrsMatrix_sumIntoGlobalValues__SWIG_0 + generic :: sumIntoLocalValues => swigf_TpetraCrsMatrix_sumIntoLocalValues__SWIG_0 + generic :: fillComplete => swigf_TpetraCrsMatrix_fillComplete__SWIG_0, swigf_TpetraCrsMatrix_fillComplete__SWIG_1, & + swigf_TpetraCrsMatrix_fillComplete__SWIG_2, swigf_TpetraCrsMatrix_fillComplete__SWIG_3 + generic :: expertStaticFillComplete => swigf_TpetraCrsMatrix_expertStaticFillComplete__SWIG_0, & + swigf_TpetraCrsMatrix_expertStaticFillComplete__SWIG_1, swigf_TpetraCrsMatrix_expertStaticFillComplete__SWIG_2, & + swigf_TpetraCrsMatrix_expertStaticFillComplete__SWIG_3 + generic :: importAndFillComplete => swigf_TpetraCrsMatrix_importAndFillComplete__SWIG_0, & + swigf_TpetraCrsMatrix_importAndFillComplete__SWIG_1, swigf_TpetraCrsMatrix_importAndFillComplete__SWIG_2 + generic :: exportAndFillComplete => swigf_TpetraCrsMatrix_exportAndFillComplete__SWIG_0, & + swigf_TpetraCrsMatrix_exportAndFillComplete__SWIG_1, swigf_TpetraCrsMatrix_exportAndFillComplete__SWIG_2, & + swigf_TpetraCrsMatrix_exportAndFillComplete__SWIG_3, swigf_TpetraCrsMatrix_exportAndFillComplete__SWIG_4 end type TpetraCrsMatrix interface TpetraCrsMatrix - module procedure new_TpetraCrsMatrix__SWIG_0 - module procedure new_TpetraCrsMatrix__SWIG_1 - module procedure new_TpetraCrsMatrix__SWIG_2 - module procedure new_TpetraCrsMatrix__SWIG_3 - module procedure new_TpetraCrsMatrix__SWIG_4 - module procedure new_TpetraCrsMatrix__SWIG_5 - module procedure new_TpetraCrsMatrix__SWIG_6 - module procedure new_TpetraCrsMatrix__SWIG_7 - module procedure new_TpetraCrsMatrix__SWIG_8 - module procedure new_TpetraCrsMatrix__SWIG_9 - module procedure new_TpetraCrsMatrix__SWIG_10 - module procedure new_TpetraCrsMatrix__SWIG_11 - module procedure new_TpetraCrsMatrix__SWIG_12 - module procedure new_TpetraCrsMatrix__SWIG_13 - module procedure new_TpetraCrsMatrix__SWIG_14 - module procedure new_TpetraCrsMatrix__SWIG_15 - module procedure new_TpetraCrsMatrix__SWIG_16 - module procedure new_TpetraCrsMatrix__SWIG_17 + module procedure swigf_new_TpetraCrsMatrix__SWIG_0 + module procedure swigf_new_TpetraCrsMatrix__SWIG_1 + module procedure swigf_new_TpetraCrsMatrix__SWIG_2 + module procedure swigf_new_TpetraCrsMatrix__SWIG_3 + module procedure swigf_new_TpetraCrsMatrix__SWIG_4 + module procedure swigf_new_TpetraCrsMatrix__SWIG_5 + module procedure swigf_new_TpetraCrsMatrix__SWIG_6 + module procedure swigf_new_TpetraCrsMatrix__SWIG_7 + module procedure swigf_new_TpetraCrsMatrix__SWIG_8 + module procedure swigf_new_TpetraCrsMatrix__SWIG_9 + module procedure swigf_new_TpetraCrsMatrix__SWIG_10 + module procedure swigf_new_TpetraCrsMatrix__SWIG_11 + module procedure swigf_new_TpetraCrsMatrix__SWIG_12 + module procedure swigf_new_TpetraCrsMatrix__SWIG_13 + module procedure swigf_new_TpetraCrsMatrix__SWIG_14 + module procedure swigf_new_TpetraCrsMatrix__SWIG_15 + module procedure swigf_new_TpetraCrsMatrix__SWIG_16 + module procedure swigf_new_TpetraCrsMatrix__SWIG_17 end interface public :: operator_to_matrix public :: matrix_to_operator + type, public :: SWIGTYPE_Tpetra__MatrixMarket__ReaderT_Tpetra__CrsMatrixT_KG2R9 + type(SwigClassWrapper), public :: swigdata + end type ! class Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > > type, public :: TpetraReader type(SwigClassWrapper), public :: swigdata contains - procedure, private, nopass :: readSparseGraphFile__SWIG_0 => TpetraReader_readSparseGraphFile__SWIG_0 - procedure, private, nopass :: readSparseGraphFile__SWIG_1 => TpetraReader_readSparseGraphFile__SWIG_1 - procedure, private, nopass :: readSparseGraphFile__SWIG_2 => TpetraReader_readSparseGraphFile__SWIG_2 - procedure, private, nopass :: readSparseGraphFile__SWIG_3 => TpetraReader_readSparseGraphFile__SWIG_3 - procedure, private, nopass :: readSparseGraphFile__SWIG_4 => TpetraReader_readSparseGraphFile__SWIG_4 - procedure, private, nopass :: readSparseFile__SWIG_0 => TpetraReader_readSparseFile__SWIG_0 - procedure, private, nopass :: readSparseFile__SWIG_1 => TpetraReader_readSparseFile__SWIG_1 - procedure, private, nopass :: readSparseFile__SWIG_2 => TpetraReader_readSparseFile__SWIG_2 - procedure, private, nopass :: readSparseFile__SWIG_3 => TpetraReader_readSparseFile__SWIG_3 - procedure, private, nopass :: readSparseFile__SWIG_4 => TpetraReader_readSparseFile__SWIG_4 - procedure, nopass :: readDenseFile => TpetraReader_readDenseFile - procedure, nopass :: readMapFile => TpetraReader_readMapFile + procedure, private, nopass :: swigf_TpetraReader_readSparseGraphFile__SWIG_0 + procedure, private, nopass :: swigf_TpetraReader_readSparseGraphFile__SWIG_1 + procedure, private, nopass :: swigf_TpetraReader_readSparseGraphFile__SWIG_2 + procedure, private, nopass :: swigf_TpetraReader_readSparseGraphFile__SWIG_3 + procedure, private, nopass :: swigf_TpetraReader_readSparseGraphFile__SWIG_4 + procedure, private, nopass :: swigf_TpetraReader_readSparseFile__SWIG_0 + procedure, private, nopass :: swigf_TpetraReader_readSparseFile__SWIG_1 + procedure, private, nopass :: swigf_TpetraReader_readSparseFile__SWIG_2 + procedure, private, nopass :: swigf_TpetraReader_readSparseFile__SWIG_3 + procedure, private, nopass :: swigf_TpetraReader_readSparseFile__SWIG_4 + procedure, nopass :: readDenseFile => swigf_TpetraReader_readDenseFile + procedure, nopass :: readMapFile => swigf_TpetraReader_readMapFile procedure :: release => delete_TpetraReader - procedure, private :: swigf_assignment_TpetraReader - generic :: assignment(=) => swigf_assignment_TpetraReader - generic :: readSparseGraphFile => readSparseGraphFile__SWIG_0, readSparseGraphFile__SWIG_1, readSparseGraphFile__SWIG_2, & - readSparseGraphFile__SWIG_3, readSparseGraphFile__SWIG_4 - generic :: readSparseFile => readSparseFile__SWIG_0, readSparseFile__SWIG_1, readSparseFile__SWIG_2, readSparseFile__SWIG_3, & - readSparseFile__SWIG_4 + procedure, private :: swigf_TpetraReader_op_assign__ + generic :: assignment(=) => swigf_TpetraReader_op_assign__ + generic :: readSparseGraphFile => swigf_TpetraReader_readSparseGraphFile__SWIG_0, & + swigf_TpetraReader_readSparseGraphFile__SWIG_1, swigf_TpetraReader_readSparseGraphFile__SWIG_2, & + swigf_TpetraReader_readSparseGraphFile__SWIG_3, swigf_TpetraReader_readSparseGraphFile__SWIG_4 + generic :: readSparseFile => swigf_TpetraReader_readSparseFile__SWIG_0, swigf_TpetraReader_readSparseFile__SWIG_1, & + swigf_TpetraReader_readSparseFile__SWIG_2, swigf_TpetraReader_readSparseFile__SWIG_3, & + swigf_TpetraReader_readSparseFile__SWIG_4 end type TpetraReader + type, public :: SWIGTYPE_Tpetra__MatrixMarket__WriterT_Tpetra__CrsMatrixT_KG2R9 + type(SwigClassWrapper), public :: swigdata + end type ! class Tpetra::MatrixMarket::Writer< Tpetra::CrsMatrix< SC,LO,GO,NO > > type, public :: TpetraWriter type(SwigClassWrapper), public :: swigdata contains - procedure, private, nopass :: writeSparseFile__SWIG_0 => TpetraWriter_writeSparseFile__SWIG_0 - procedure, private, nopass :: writeSparseFile__SWIG_1 => TpetraWriter_writeSparseFile__SWIG_1 - procedure, private, nopass :: writeSparseGraphFile__SWIG_0 => TpetraWriter_writeSparseGraphFile__SWIG_0 - procedure, private, nopass :: writeSparseGraphFile__SWIG_1 => TpetraWriter_writeSparseGraphFile__SWIG_1 - procedure, private, nopass :: writeDenseFile__SWIG_0 => TpetraWriter_writeDenseFile__SWIG_0 - procedure, private, nopass :: writeDenseFile__SWIG_1 => TpetraWriter_writeDenseFile__SWIG_1 + procedure, private, nopass :: swigf_TpetraWriter_writeSparseFile__SWIG_0 + procedure, private, nopass :: swigf_TpetraWriter_writeSparseFile__SWIG_1 + procedure, private, nopass :: swigf_TpetraWriter_writeSparseGraphFile__SWIG_0 + procedure, private, nopass :: swigf_TpetraWriter_writeSparseGraphFile__SWIG_1 + procedure, private, nopass :: swigf_TpetraWriter_writeDenseFile__SWIG_0 + procedure, private, nopass :: swigf_TpetraWriter_writeDenseFile__SWIG_1 procedure :: release => delete_TpetraWriter - procedure, private :: swigf_assignment_TpetraWriter - generic :: assignment(=) => swigf_assignment_TpetraWriter - generic :: writeSparseGraphFile => writeSparseGraphFile__SWIG_0, writeSparseGraphFile__SWIG_1 - generic :: writeSparseFile => writeSparseFile__SWIG_0, writeSparseFile__SWIG_1 - generic :: writeDenseFile => writeDenseFile__SWIG_0, writeDenseFile__SWIG_1 + procedure, private :: swigf_TpetraWriter_op_assign__ + generic :: assignment(=) => swigf_TpetraWriter_op_assign__ + generic :: writeSparseGraphFile => swigf_TpetraWriter_writeSparseGraphFile__SWIG_0, & + swigf_TpetraWriter_writeSparseGraphFile__SWIG_1 + generic :: writeSparseFile => swigf_TpetraWriter_writeSparseFile__SWIG_0, swigf_TpetraWriter_writeSparseFile__SWIG_1 + generic :: writeDenseFile => swigf_TpetraWriter_writeDenseFile__SWIG_0, swigf_TpetraWriter_writeDenseFile__SWIG_1 end type TpetraWriter interface TpetraMatrixMatrixAdd - module procedure TpetraMatrixMatrixAdd__SWIG_0, TpetraMatrixMatrixAdd__SWIG_1 + module procedure swigf_TpetraMatrixMatrixAdd__SWIG_0, swigf_TpetraMatrixMatrixAdd__SWIG_1 end interface public :: TpetraMatrixMatrixAdd interface TpetraMatrixMatrixMultiply - module procedure TpetraMatrixMatrixMultiply__SWIG_0, TpetraMatrixMatrixMultiply__SWIG_1, TpetraMatrixMatrixMultiply__SWIG_2, & - TpetraMatrixMatrixMultiply__SWIG_3 + module procedure swigf_TpetraMatrixMatrixMultiply__SWIG_0, swigf_TpetraMatrixMatrixMultiply__SWIG_1, & + swigf_TpetraMatrixMatrixMultiply__SWIG_2, swigf_TpetraMatrixMatrixMultiply__SWIG_3 end interface public :: TpetraMatrixMatrixMultiply @@ -766,7 +810,7 @@ subroutine swigc_delete_TpetraMap(farg1) & bind(C, name="_wrap_delete_TpetraMap") use, intrinsic :: ISO_C_BINDING import :: swigclasswrapper -type(SwigClassWrapper) :: farg1 +type(SwigClassWrapper), intent(inout) :: farg1 end subroutine function swigc_TpetraMap_isOneToOne(farg1) & @@ -1030,13 +1074,14 @@ function swigc_TpetraMap_replaceCommWithSubset(farg1, farg2) & type(SwigClassWrapper) :: fresult end function - subroutine swigc_assignment_TpetraMap(self, other) & - bind(C, name="_wrap_assign_TpetraMap") - use, intrinsic :: ISO_C_BINDING - import :: SwigClassWrapper - type(SwigClassWrapper), intent(inout) :: self - type(SwigClassWrapper), intent(in) :: other - end subroutine +subroutine swigc_TpetraMap_op_assign__(farg1, farg2) & +bind(C, name="_wrap_TpetraMap_op_assign__") +use, intrinsic :: ISO_C_BINDING +import :: swigclasswrapper +type(SwigClassWrapper), intent(inout) :: farg1 +type(SwigClassWrapper) :: farg2 +end subroutine + function swigc_new_TpetraImport__SWIG_0(farg1, farg2) & bind(C, name="_wrap_new_TpetraImport__SWIG_0") & result(fresult) @@ -1080,7 +1125,7 @@ subroutine swigc_delete_TpetraImport(farg1) & bind(C, name="_wrap_delete_TpetraImport") use, intrinsic :: ISO_C_BINDING import :: swigclasswrapper -type(SwigClassWrapper) :: farg1 +type(SwigClassWrapper), intent(inout) :: farg1 end subroutine subroutine swigc_TpetraImport_setParameterList(farg1, farg2) & @@ -1191,13 +1236,14 @@ subroutine swigc_TpetraImport_print(farg1, farg2) & type(SwigClassWrapper) :: farg2 end subroutine - subroutine swigc_assignment_TpetraImport(self, other) & - bind(C, name="_wrap_assign_TpetraImport") - use, intrinsic :: ISO_C_BINDING - import :: SwigClassWrapper - type(SwigClassWrapper), intent(inout) :: self - type(SwigClassWrapper), intent(in) :: other - end subroutine +subroutine swigc_TpetraImport_op_assign__(farg1, farg2) & +bind(C, name="_wrap_TpetraImport_op_assign__") +use, intrinsic :: ISO_C_BINDING +import :: swigclasswrapper +type(SwigClassWrapper), intent(inout) :: farg1 +type(SwigClassWrapper) :: farg2 +end subroutine + function swigc_new_TpetraExport__SWIG_0(farg1, farg2) & bind(C, name="_wrap_new_TpetraExport__SWIG_0") & result(fresult) @@ -1241,7 +1287,7 @@ subroutine swigc_delete_TpetraExport(farg1) & bind(C, name="_wrap_delete_TpetraExport") use, intrinsic :: ISO_C_BINDING import :: swigclasswrapper -type(SwigClassWrapper) :: farg1 +type(SwigClassWrapper), intent(inout) :: farg1 end subroutine subroutine swigc_TpetraExport_setParameterList(farg1, farg2) & @@ -1323,13 +1369,14 @@ subroutine swigc_TpetraExport_print(farg1, farg2) & type(SwigClassWrapper) :: farg2 end subroutine - subroutine swigc_assignment_TpetraExport(self, other) & - bind(C, name="_wrap_assign_TpetraExport") - use, intrinsic :: ISO_C_BINDING - import :: SwigClassWrapper - type(SwigClassWrapper), intent(inout) :: self - type(SwigClassWrapper), intent(in) :: other - end subroutine +subroutine swigc_TpetraExport_op_assign__(farg1, farg2) & +bind(C, name="_wrap_TpetraExport_op_assign__") +use, intrinsic :: ISO_C_BINDING +import :: swigclasswrapper +type(SwigClassWrapper), intent(inout) :: farg1 +type(SwigClassWrapper) :: farg2 +end subroutine + function swigc_new_TpetraMultiVector__SWIG_0() & bind(C, name="_wrap_new_TpetraMultiVector__SWIG_0") & result(fresult) @@ -1424,7 +1471,7 @@ subroutine swigc_delete_TpetraMultiVector(farg1) & bind(C, name="_wrap_delete_TpetraMultiVector") use, intrinsic :: ISO_C_BINDING import :: swigclasswrapper -type(SwigClassWrapper) :: farg1 +type(SwigClassWrapper), intent(inout) :: farg1 end subroutine subroutine swigc_TpetraMultiVector_replaceGlobalValue(farg1, farg2, farg3, farg4) & @@ -1967,27 +2014,29 @@ subroutine swigc_TpetraMultiVector_doExport__SWIG_1(farg1, farg2, farg3, farg4) integer(C_INT), intent(in) :: farg4 end subroutine - subroutine swigc_assignment_TpetraMultiVector(self, other) & - bind(C, name="_wrap_assign_TpetraMultiVector") - use, intrinsic :: ISO_C_BINDING - import :: SwigClassWrapper - type(SwigClassWrapper), intent(inout) :: self - type(SwigClassWrapper), intent(in) :: other - end subroutine +subroutine swigc_TpetraMultiVector_op_assign__(farg1, farg2) & +bind(C, name="_wrap_TpetraMultiVector_op_assign__") +use, intrinsic :: ISO_C_BINDING +import :: swigclasswrapper +type(SwigClassWrapper), intent(inout) :: farg1 +type(SwigClassWrapper) :: farg2 +end subroutine + subroutine swigc_delete_TpetraOperator(farg1) & bind(C, name="_wrap_delete_TpetraOperator") use, intrinsic :: ISO_C_BINDING import :: swigclasswrapper -type(SwigClassWrapper) :: farg1 +type(SwigClassWrapper), intent(inout) :: farg1 +end subroutine + +subroutine swigc_TpetraOperator_op_assign__(farg1, farg2) & +bind(C, name="_wrap_TpetraOperator_op_assign__") +use, intrinsic :: ISO_C_BINDING +import :: swigclasswrapper +type(SwigClassWrapper), intent(inout) :: farg1 +type(SwigClassWrapper) :: farg2 end subroutine - subroutine swigc_assignment_TpetraOperator(self, other) & - bind(C, name="_wrap_assign_TpetraOperator") - use, intrinsic :: ISO_C_BINDING - import :: SwigClassWrapper - type(SwigClassWrapper), intent(inout) :: self - type(SwigClassWrapper), intent(in) :: other - end subroutine function swigc_ForTpetraOperator_fhandle(farg1) & bind(C, name="_wrap_ForTpetraOperator_fhandle") & result(fresult) @@ -2047,16 +2096,17 @@ subroutine swigc_delete_ForTpetraOperator(farg1) & bind(C, name="_wrap_delete_ForTpetraOperator") use, intrinsic :: ISO_C_BINDING import :: swigclasswrapper -type(SwigClassWrapper) :: farg1 +type(SwigClassWrapper), intent(inout) :: farg1 +end subroutine + +subroutine swigc_ForTpetraOperator_op_assign__(farg1, farg2) & +bind(C, name="_wrap_ForTpetraOperator_op_assign__") +use, intrinsic :: ISO_C_BINDING +import :: swigclasswrapper +type(SwigClassWrapper), intent(inout) :: farg1 +type(SwigClassWrapper) :: farg2 end subroutine - subroutine swigc_assignment_ForTpetraOperator(self, other) & - bind(C, name="_wrap_assign_ForTpetraOperator") - use, intrinsic :: ISO_C_BINDING - import :: SwigClassWrapper - type(SwigClassWrapper), intent(inout) :: self - type(SwigClassWrapper), intent(in) :: other - end subroutine subroutine swigc_RowInfo_localRow_set(farg1, farg2) & bind(C, name="_wrap_RowInfo_localRow_set") use, intrinsic :: ISO_C_BINDING @@ -2137,16 +2187,17 @@ subroutine swigc_delete_RowInfo(farg1) & bind(C, name="_wrap_delete_RowInfo") use, intrinsic :: ISO_C_BINDING import :: swigclasswrapper -type(SwigClassWrapper) :: farg1 +type(SwigClassWrapper), intent(inout) :: farg1 +end subroutine + +subroutine swigc_RowInfo_op_assign__(farg1, farg2) & +bind(C, name="_wrap_RowInfo_op_assign__") +use, intrinsic :: ISO_C_BINDING +import :: swigclasswrapper +type(SwigClassWrapper), intent(inout) :: farg1 +type(SwigClassWrapper) :: farg2 end subroutine - subroutine swigc_assignment_RowInfo(self, other) & - bind(C, name="_wrap_assign_RowInfo") - use, intrinsic :: ISO_C_BINDING - import :: SwigClassWrapper - type(SwigClassWrapper), intent(inout) :: self - type(SwigClassWrapper), intent(in) :: other - end subroutine function swigc_new_TpetraCrsGraph__SWIG_0(farg1, farg2, farg3, farg4) & bind(C, name="_wrap_new_TpetraCrsGraph__SWIG_0") & result(fresult) @@ -2322,7 +2373,7 @@ subroutine swigc_delete_TpetraCrsGraph(farg1) & bind(C, name="_wrap_delete_TpetraCrsGraph") use, intrinsic :: ISO_C_BINDING import :: swigclasswrapper -type(SwigClassWrapper) :: farg1 +type(SwigClassWrapper), intent(inout) :: farg1 end subroutine subroutine swigc_TpetraCrsGraph_swap(farg1, farg2) & @@ -3011,13 +3062,14 @@ subroutine swigc_TpetraCrsGraph_doExport__SWIG_1(farg1, farg2, farg3, farg4) & integer(C_INT), intent(in) :: farg4 end subroutine - subroutine swigc_assignment_TpetraCrsGraph(self, other) & - bind(C, name="_wrap_assign_TpetraCrsGraph") - use, intrinsic :: ISO_C_BINDING - import :: SwigClassWrapper - type(SwigClassWrapper), intent(inout) :: self - type(SwigClassWrapper), intent(in) :: other - end subroutine +subroutine swigc_TpetraCrsGraph_op_assign__(farg1, farg2) & +bind(C, name="_wrap_TpetraCrsGraph_op_assign__") +use, intrinsic :: ISO_C_BINDING +import :: swigclasswrapper +type(SwigClassWrapper), intent(inout) :: farg1 +type(SwigClassWrapper) :: farg2 +end subroutine + function swigc_new_TpetraCrsMatrix__SWIG_0(farg1, farg2, farg3, farg4) & bind(C, name="_wrap_new_TpetraCrsMatrix__SWIG_0") & result(fresult) @@ -3235,7 +3287,7 @@ subroutine swigc_delete_TpetraCrsMatrix(farg1) & bind(C, name="_wrap_delete_TpetraCrsMatrix") use, intrinsic :: ISO_C_BINDING import :: swigclasswrapper -type(SwigClassWrapper) :: farg1 +type(SwigClassWrapper), intent(inout) :: farg1 end subroutine subroutine swigc_TpetraCrsMatrix_insertGlobalValues(farg1, farg2, farg3, farg4) & @@ -3990,13 +4042,14 @@ subroutine swigc_TpetraCrsMatrix_getAllValues(farg1, farg2, farg3, farg4) & type(SwigArrayWrapper) :: farg4 end subroutine - subroutine swigc_assignment_TpetraCrsMatrix(self, other) & - bind(C, name="_wrap_assign_TpetraCrsMatrix") - use, intrinsic :: ISO_C_BINDING - import :: SwigClassWrapper - type(SwigClassWrapper), intent(inout) :: self - type(SwigClassWrapper), intent(in) :: other - end subroutine +subroutine swigc_TpetraCrsMatrix_op_assign__(farg1, farg2) & +bind(C, name="_wrap_TpetraCrsMatrix_op_assign__") +use, intrinsic :: ISO_C_BINDING +import :: swigclasswrapper +type(SwigClassWrapper), intent(inout) :: farg1 +type(SwigClassWrapper) :: farg2 +end subroutine + function swigc_operator_to_matrix(farg1) & bind(C, name="_wrap_operator_to_matrix") & result(fresult) @@ -4172,16 +4225,17 @@ subroutine swigc_delete_TpetraReader(farg1) & bind(C, name="_wrap_delete_TpetraReader") use, intrinsic :: ISO_C_BINDING import :: swigclasswrapper -type(SwigClassWrapper) :: farg1 +type(SwigClassWrapper), intent(inout) :: farg1 +end subroutine + +subroutine swigc_TpetraReader_op_assign__(farg1, farg2) & +bind(C, name="_wrap_TpetraReader_op_assign__") +use, intrinsic :: ISO_C_BINDING +import :: swigclasswrapper +type(SwigClassWrapper), intent(inout) :: farg1 +type(SwigClassWrapper) :: farg2 end subroutine - subroutine swigc_assignment_TpetraReader(self, other) & - bind(C, name="_wrap_assign_TpetraReader") - use, intrinsic :: ISO_C_BINDING - import :: SwigClassWrapper - type(SwigClassWrapper), intent(inout) :: self - type(SwigClassWrapper), intent(in) :: other - end subroutine subroutine swigc_TpetraWriter_writeSparseFile__SWIG_0(farg1, farg2, farg3, farg4) & bind(C, name="_wrap_TpetraWriter_writeSparseFile__SWIG_0") use, intrinsic :: ISO_C_BINDING @@ -4246,16 +4300,17 @@ subroutine swigc_delete_TpetraWriter(farg1) & bind(C, name="_wrap_delete_TpetraWriter") use, intrinsic :: ISO_C_BINDING import :: swigclasswrapper -type(SwigClassWrapper) :: farg1 +type(SwigClassWrapper), intent(inout) :: farg1 +end subroutine + +subroutine swigc_TpetraWriter_op_assign__(farg1, farg2) & +bind(C, name="_wrap_TpetraWriter_op_assign__") +use, intrinsic :: ISO_C_BINDING +import :: swigclasswrapper +type(SwigClassWrapper), intent(inout) :: farg1 +type(SwigClassWrapper) :: farg2 end subroutine - subroutine swigc_assignment_TpetraWriter(self, other) & - bind(C, name="_wrap_assign_TpetraWriter") - use, intrinsic :: ISO_C_BINDING - import :: SwigClassWrapper - type(SwigClassWrapper), intent(inout) :: self - type(SwigClassWrapper), intent(in) :: other - end subroutine subroutine swigc_TpetraMatrixMatrixMultiply__SWIG_0(farg1, farg2, farg3, farg4, farg5, farg6, farg7, farg8) & bind(C, name="_wrap_TpetraMatrixMatrixMultiply__SWIG_0") use, intrinsic :: ISO_C_BINDING @@ -4357,11 +4412,9 @@ subroutine SWIG_string_to_chararray(string, chars, wrap) subroutine setCombineModeParameter(plist, paramname) use, intrinsic :: ISO_C_BINDING -class(ParameterList), intent(inout) :: plist - +class(ParameterList), intent(in) :: plist character(kind=C_CHAR, len=*), target :: paramname character(kind=C_CHAR), dimension(:), allocatable, target :: farg2_chars - type(SwigClassWrapper) :: farg1 type(SwigArrayWrapper) :: farg2 @@ -4389,7 +4442,6 @@ function combineModeToString(combinemode) & use, intrinsic :: ISO_C_BINDING character(kind=C_CHAR, len=:), allocatable :: swig_result integer(TpetraCombineMode), intent(in) :: combinemode - type(SwigArrayWrapper) :: fresult integer(C_INT) :: farg1 @@ -4399,16 +4451,14 @@ function combineModeToString(combinemode) & call SWIG_free(fresult%data) end function -function new_TpetraMap__SWIG_0(numglobalelements, comm, lg, node) & +function swigf_new_TpetraMap__SWIG_0(numglobalelements, comm, lg, node) & result(self) use, intrinsic :: ISO_C_BINDING type(TpetraMap) :: self integer(C_LONG), intent(in) :: numglobalelements class(TeuchosComm), intent(in) :: comm - integer(TpetraLocalGlobal), intent(in) :: lg class(SWIGTYPE_Teuchos__RCPT_Kokkos__Compat__KokkosSerialWrapper9ZCDM), intent(in) :: node - type(SwigClassWrapper) :: fresult integer(C_LONG) :: farg1 type(SwigClassWrapper) :: farg3 @@ -4423,15 +4473,13 @@ function new_TpetraMap__SWIG_0(numglobalelements, comm, lg, node) & self%swigdata = fresult end function -function new_TpetraMap__SWIG_1(numglobalelements, comm, lg) & +function swigf_new_TpetraMap__SWIG_1(numglobalelements, comm, lg) & result(self) use, intrinsic :: ISO_C_BINDING type(TpetraMap) :: self integer(C_LONG), intent(in) :: numglobalelements class(TeuchosComm), intent(in) :: comm - integer(TpetraLocalGlobal), intent(in) :: lg - type(SwigClassWrapper) :: fresult integer(C_LONG) :: farg1 type(SwigClassWrapper) :: farg3 @@ -4444,13 +4492,12 @@ function new_TpetraMap__SWIG_1(numglobalelements, comm, lg) & self%swigdata = fresult end function -function new_TpetraMap__SWIG_2(numglobalelements, comm) & +function swigf_new_TpetraMap__SWIG_2(numglobalelements, comm) & result(self) use, intrinsic :: ISO_C_BINDING type(TpetraMap) :: self integer(C_LONG), intent(in) :: numglobalelements class(TeuchosComm), intent(in) :: comm - type(SwigClassWrapper) :: fresult integer(C_LONG) :: farg1 type(SwigClassWrapper) :: farg3 @@ -4461,16 +4508,14 @@ function new_TpetraMap__SWIG_2(numglobalelements, comm) & self%swigdata = fresult end function -function new_TpetraMap__SWIG_3(numglobalelements, numlocalelements, comm, node) & +function swigf_new_TpetraMap__SWIG_3(numglobalelements, numlocalelements, comm, node) & result(self) use, intrinsic :: ISO_C_BINDING type(TpetraMap) :: self integer(C_LONG), intent(in) :: numglobalelements integer, intent(in) :: numlocalelements class(TeuchosComm), intent(in) :: comm - class(SWIGTYPE_Teuchos__RCPT_Kokkos__Compat__KokkosSerialWrapper9ZCDM), intent(in) :: node - type(SwigClassWrapper) :: fresult integer(C_LONG) :: farg1 integer(C_INT) :: farg2 @@ -4485,14 +4530,13 @@ function new_TpetraMap__SWIG_3(numglobalelements, numlocalelements, comm, node) self%swigdata = fresult end function -function new_TpetraMap__SWIG_4(numglobalelements, numlocalelements, comm) & +function swigf_new_TpetraMap__SWIG_4(numglobalelements, numlocalelements, comm) & result(self) use, intrinsic :: ISO_C_BINDING type(TpetraMap) :: self integer(C_LONG), intent(in) :: numglobalelements integer, intent(in) :: numlocalelements class(TeuchosComm), intent(in) :: comm - type(SwigClassWrapper) :: fresult integer(C_LONG) :: farg1 integer(C_INT) :: farg2 @@ -4505,7 +4549,7 @@ function new_TpetraMap__SWIG_4(numglobalelements, numlocalelements, comm) & self%swigdata = fresult end function -function new_TpetraMap__SWIG_5(numglobalelements, indexlist, comm, node) & +function swigf_new_TpetraMap__SWIG_5(numglobalelements, indexlist, comm, node) & result(self) use, intrinsic :: ISO_C_BINDING type(TpetraMap) :: self @@ -4513,9 +4557,7 @@ function new_TpetraMap__SWIG_5(numglobalelements, indexlist, comm, node) & integer(C_LONG_LONG), dimension(:), target :: indexlist integer(C_LONG_LONG), pointer :: farg2_view class(TeuchosComm), intent(in) :: comm - class(SWIGTYPE_Teuchos__RCPT_Kokkos__Compat__KokkosSerialWrapper9ZCDM), intent(in) :: node - type(SwigClassWrapper) :: fresult integer(C_LONG) :: farg1 type(SwigArrayWrapper) :: farg2 @@ -4537,7 +4579,7 @@ function new_TpetraMap__SWIG_5(numglobalelements, indexlist, comm, node) & self%swigdata = fresult end function -function new_TpetraMap__SWIG_6(numglobalelements, indexlist, comm) & +function swigf_new_TpetraMap__SWIG_6(numglobalelements, indexlist, comm) & result(self) use, intrinsic :: ISO_C_BINDING type(TpetraMap) :: self @@ -4545,7 +4587,6 @@ function new_TpetraMap__SWIG_6(numglobalelements, indexlist, comm) & integer(C_LONG_LONG), dimension(:), target :: indexlist integer(C_LONG_LONG), pointer :: farg2_view class(TeuchosComm), intent(in) :: comm - type(SwigClassWrapper) :: fresult integer(C_LONG) :: farg1 type(SwigArrayWrapper) :: farg2 @@ -4565,11 +4606,10 @@ function new_TpetraMap__SWIG_6(numglobalelements, indexlist, comm) & self%swigdata = fresult end function -function new_TpetraMap__SWIG_7() & +function swigf_new_TpetraMap__SWIG_7() & result(self) use, intrinsic :: ISO_C_BINDING type(TpetraMap) :: self - type(SwigClassWrapper) :: fresult fresult = swigc_new_TpetraMap__SWIG_7() @@ -4579,7 +4619,6 @@ function new_TpetraMap__SWIG_7() & subroutine delete_TpetraMap(self) use, intrinsic :: ISO_C_BINDING class(TpetraMap), intent(inout) :: self - type(SwigClassWrapper) :: farg1 farg1 = self%swigdata @@ -4608,7 +4647,6 @@ function swigf_TpetraMap_isOneToOne(self) & use, intrinsic :: ISO_C_BINDING logical :: swig_result class(TpetraMap), intent(in) :: self - integer(C_INT) :: fresult type(SwigClassWrapper) :: farg1 @@ -4622,7 +4660,6 @@ function swigf_TpetraMap_getGlobalNumElements(self) & use, intrinsic :: ISO_C_BINDING integer(C_LONG) :: swig_result class(TpetraMap), intent(in) :: self - integer(C_LONG) :: fresult type(SwigClassWrapper) :: farg1 @@ -4636,7 +4673,6 @@ function swigf_TpetraMap_getNodeNumElements(self) & use, intrinsic :: ISO_C_BINDING integer :: swig_result class(TpetraMap), intent(in) :: self - integer(C_INT) :: fresult type(SwigClassWrapper) :: farg1 @@ -4650,7 +4686,6 @@ function swigf_TpetraMap_getMinLocalIndex(self) & use, intrinsic :: ISO_C_BINDING integer :: swig_result class(TpetraMap), intent(in) :: self - integer(C_INT) :: fresult type(SwigClassWrapper) :: farg1 @@ -4664,7 +4699,6 @@ function swigf_TpetraMap_getMaxLocalIndex(self) & use, intrinsic :: ISO_C_BINDING integer :: swig_result class(TpetraMap), intent(in) :: self - integer(C_INT) :: fresult type(SwigClassWrapper) :: farg1 @@ -4678,7 +4712,6 @@ function swigf_TpetraMap_getMinGlobalIndex(self) & use, intrinsic :: ISO_C_BINDING integer(C_LONG_LONG) :: swig_result class(TpetraMap), intent(in) :: self - integer(C_LONG_LONG) :: fresult type(SwigClassWrapper) :: farg1 @@ -4692,7 +4725,6 @@ function swigf_TpetraMap_getMaxGlobalIndex(self) & use, intrinsic :: ISO_C_BINDING integer(C_LONG_LONG) :: swig_result class(TpetraMap), intent(in) :: self - integer(C_LONG_LONG) :: fresult type(SwigClassWrapper) :: farg1 @@ -4706,7 +4738,6 @@ function swigf_TpetraMap_getMinAllGlobalIndex(self) & use, intrinsic :: ISO_C_BINDING integer(C_LONG_LONG) :: swig_result class(TpetraMap), intent(in) :: self - integer(C_LONG_LONG) :: fresult type(SwigClassWrapper) :: farg1 @@ -4720,7 +4751,6 @@ function swigf_TpetraMap_getMaxAllGlobalIndex(self) & use, intrinsic :: ISO_C_BINDING integer(C_LONG_LONG) :: swig_result class(TpetraMap), intent(in) :: self - integer(C_LONG_LONG) :: fresult type(SwigClassWrapper) :: farg1 @@ -4734,9 +4764,7 @@ function swigf_TpetraMap_getLocalElement(self, globalindex) & use, intrinsic :: ISO_C_BINDING integer :: swig_result class(TpetraMap), intent(in) :: self - integer(C_LONG_LONG), intent(in) :: globalindex - integer(C_INT) :: fresult type(SwigClassWrapper) :: farg1 integer(C_LONG_LONG) :: farg2 @@ -4752,9 +4780,7 @@ function swigf_TpetraMap_getGlobalElement(self, localindex) & use, intrinsic :: ISO_C_BINDING integer(C_LONG_LONG) :: swig_result class(TpetraMap), intent(in) :: self - integer, intent(in) :: localindex - integer(C_LONG_LONG) :: fresult type(SwigClassWrapper) :: farg1 integer(C_INT) :: farg2 @@ -4770,14 +4796,12 @@ function swigf_TpetraMap_getRemoteIndexList__SWIG_0(self, gidlist, nodeidlist, l use, intrinsic :: ISO_C_BINDING integer(TpetraLookupStatus) :: swig_result class(TpetraMap), intent(in) :: self - integer(C_LONG_LONG), dimension(:), target :: gidlist integer(C_LONG_LONG), pointer :: farg2_view integer(C_INT), dimension(:), target :: nodeidlist integer(C_INT), pointer :: farg3_view integer(C_INT), dimension(:), target :: lidlist integer(C_INT), pointer :: farg4_view - integer(C_INT) :: fresult type(SwigClassWrapper) :: farg1 type(SwigArrayWrapper) :: farg2 @@ -4818,12 +4842,10 @@ function swigf_TpetraMap_getRemoteIndexList__SWIG_1(self, gidlist, nodeidlist) & use, intrinsic :: ISO_C_BINDING integer(TpetraLookupStatus) :: swig_result class(TpetraMap), intent(in) :: self - integer(C_LONG_LONG), dimension(:), target :: gidlist integer(C_LONG_LONG), pointer :: farg2_view integer(C_INT), dimension(:), target :: nodeidlist integer(C_INT), pointer :: farg3_view - integer(C_INT) :: fresult type(SwigClassWrapper) :: farg1 type(SwigArrayWrapper) :: farg2 @@ -4855,7 +4877,6 @@ function swigf_TpetraMap_getNodeElementList(self) & use, intrinsic :: ISO_C_BINDING integer(C_LONG_LONG), dimension(:), pointer :: swig_result class(TpetraMap), intent(in) :: self - type(SwigArrayWrapper) :: fresult type(SwigClassWrapper) :: farg1 @@ -4873,9 +4894,7 @@ function swigf_TpetraMap_isNodeLocalElement(self, localindex) & use, intrinsic :: ISO_C_BINDING logical :: swig_result class(TpetraMap), intent(in) :: self - integer, intent(in) :: localindex - integer(C_INT) :: fresult type(SwigClassWrapper) :: farg1 integer(C_INT) :: farg2 @@ -4891,9 +4910,7 @@ function swigf_TpetraMap_isNodeGlobalElement(self, globalindex) & use, intrinsic :: ISO_C_BINDING logical :: swig_result class(TpetraMap), intent(in) :: self - integer(C_LONG_LONG), intent(in) :: globalindex - integer(C_INT) :: fresult type(SwigClassWrapper) :: farg1 integer(C_LONG_LONG) :: farg2 @@ -4909,7 +4926,6 @@ function swigf_TpetraMap_isUniform(self) & use, intrinsic :: ISO_C_BINDING logical :: swig_result class(TpetraMap), intent(in) :: self - integer(C_INT) :: fresult type(SwigClassWrapper) :: farg1 @@ -4923,7 +4939,6 @@ function swigf_TpetraMap_isContiguous(self) & use, intrinsic :: ISO_C_BINDING logical :: swig_result class(TpetraMap), intent(in) :: self - integer(C_INT) :: fresult type(SwigClassWrapper) :: farg1 @@ -4937,7 +4952,6 @@ function swigf_TpetraMap_isDistributed(self) & use, intrinsic :: ISO_C_BINDING logical :: swig_result class(TpetraMap), intent(in) :: self - integer(C_INT) :: fresult type(SwigClassWrapper) :: farg1 @@ -4951,9 +4965,7 @@ function swigf_TpetraMap_isCompatible(self, map) & use, intrinsic :: ISO_C_BINDING logical :: swig_result class(TpetraMap), intent(in) :: self - class(TpetraMap), intent(in) :: map - integer(C_INT) :: fresult type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 @@ -4969,9 +4981,7 @@ function swigf_TpetraMap_isSameAs(self, map) & use, intrinsic :: ISO_C_BINDING logical :: swig_result class(TpetraMap), intent(in) :: self - class(TpetraMap), intent(in) :: map - integer(C_INT) :: fresult type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 @@ -4987,9 +4997,7 @@ function swigf_TpetraMap_locallySameAs(self, map) & use, intrinsic :: ISO_C_BINDING logical :: swig_result class(TpetraMap), intent(in) :: self - class(TpetraMap), intent(in) :: map - integer(C_INT) :: fresult type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 @@ -5005,9 +5013,7 @@ function swigf_TpetraMap_isLocallyFitted(self, map) & use, intrinsic :: ISO_C_BINDING logical :: swig_result class(TpetraMap), intent(in) :: self - class(TpetraMap), intent(in) :: map - integer(C_INT) :: fresult type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 @@ -5023,7 +5029,6 @@ function swigf_TpetraMap_getComm(self) & use, intrinsic :: ISO_C_BINDING type(TeuchosComm) :: swig_result class(TpetraMap), intent(in) :: self - type(SwigClassWrapper) :: fresult type(SwigClassWrapper) :: farg1 @@ -5037,7 +5042,6 @@ function swigf_TpetraMap_description(self) & use, intrinsic :: ISO_C_BINDING character(kind=C_CHAR, len=:), allocatable :: swig_result class(TpetraMap), intent(in) :: self - type(SwigArrayWrapper) :: fresult type(SwigClassWrapper) :: farg1 @@ -5052,7 +5056,6 @@ function swigf_TpetraMap_removeEmptyProcesses(self) & use, intrinsic :: ISO_C_BINDING type(TpetraMap) :: swig_result class(TpetraMap), intent(in) :: self - type(SwigClassWrapper) :: fresult type(SwigClassWrapper) :: farg1 @@ -5066,9 +5069,7 @@ function swigf_TpetraMap_replaceCommWithSubset(self, newcomm) & use, intrinsic :: ISO_C_BINDING type(TpetraMap) :: swig_result class(TpetraMap), intent(in) :: self - class(TeuchosComm), intent(in) :: newcomm - type(SwigClassWrapper) :: fresult type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 @@ -5079,20 +5080,25 @@ function swigf_TpetraMap_replaceCommWithSubset(self, newcomm) & swig_result%swigdata = fresult end function - subroutine swigf_assignment_TpetraMap(self, other) - use, intrinsic :: ISO_C_BINDING - class(TpetraMap), intent(inout) :: self - type(TpetraMap), intent(in) :: other - call swigc_assignment_TpetraMap(self%swigdata, other%swigdata) - end subroutine -function new_TpetraImport__SWIG_0(source, target) & +subroutine swigf_TpetraMap_op_assign__(self, other) +use, intrinsic :: ISO_C_BINDING +class(TpetraMap), intent(inout) :: self +type(SWIGTYPE_Tpetra__MapT_LO_GO_NO_t), intent(in) :: other +type(SwigClassWrapper) :: farg1 +type(SwigClassWrapper) :: farg2 + +farg1 = self%swigdata +farg2 = other%swigdata +call swigc_TpetraMap_op_assign__(farg1, farg2) +self%swigdata = farg1 +end subroutine + +function swigf_new_TpetraImport__SWIG_0(source, target) & result(self) use, intrinsic :: ISO_C_BINDING type(TpetraImport) :: self class(TpetraMap), intent(in) :: source - class(TpetraMap), intent(in) :: target - type(SwigClassWrapper) :: fresult type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 @@ -5103,16 +5109,13 @@ function new_TpetraImport__SWIG_0(source, target) & self%swigdata = fresult end function -function new_TpetraImport__SWIG_1(source, target, plist) & +function swigf_new_TpetraImport__SWIG_1(source, target, plist) & result(self) use, intrinsic :: ISO_C_BINDING type(TpetraImport) :: self class(TpetraMap), intent(in) :: source - class(TpetraMap), intent(in) :: target - class(ParameterList), intent(in) :: plist - type(SwigClassWrapper) :: fresult type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 @@ -5125,12 +5128,11 @@ function new_TpetraImport__SWIG_1(source, target, plist) & self%swigdata = fresult end function -function new_TpetraImport__SWIG_2(importer) & +function swigf_new_TpetraImport__SWIG_2(importer) & result(self) use, intrinsic :: ISO_C_BINDING type(TpetraImport) :: self class(TpetraImport), intent(in) :: importer - type(SwigClassWrapper) :: fresult type(SwigClassWrapper) :: farg1 @@ -5139,12 +5141,11 @@ function new_TpetraImport__SWIG_2(importer) & self%swigdata = fresult end function -function new_TpetraImport__SWIG_3(exporter) & +function swigf_new_TpetraImport__SWIG_3(exporter) & result(self) use, intrinsic :: ISO_C_BINDING type(TpetraImport) :: self class(TpetraExport), intent(in) :: exporter - type(SwigClassWrapper) :: fresult type(SwigClassWrapper) :: farg1 @@ -5156,7 +5157,6 @@ function new_TpetraImport__SWIG_3(exporter) & subroutine delete_TpetraImport(self) use, intrinsic :: ISO_C_BINDING class(TpetraImport), intent(inout) :: self - type(SwigClassWrapper) :: farg1 farg1 = self%swigdata @@ -5169,10 +5169,8 @@ subroutine delete_TpetraImport(self) subroutine swigf_TpetraImport_setParameterList(self, plist) use, intrinsic :: ISO_C_BINDING -class(TpetraImport), intent(inout) :: self - +class(TpetraImport), intent(in) :: self class(ParameterList), intent(in) :: plist - type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 @@ -5186,7 +5184,6 @@ function swigf_TpetraImport_getNumSameIDs(self) & use, intrinsic :: ISO_C_BINDING integer(C_SIZE_T) :: swig_result class(TpetraImport), intent(in) :: self - integer(C_SIZE_T) :: fresult type(SwigClassWrapper) :: farg1 @@ -5200,7 +5197,6 @@ function swigf_TpetraImport_getNumPermuteIDs(self) & use, intrinsic :: ISO_C_BINDING integer(C_SIZE_T) :: swig_result class(TpetraImport), intent(in) :: self - integer(C_SIZE_T) :: fresult type(SwigClassWrapper) :: farg1 @@ -5214,7 +5210,6 @@ function swigf_TpetraImport_getNumRemoteIDs(self) & use, intrinsic :: ISO_C_BINDING integer(C_SIZE_T) :: swig_result class(TpetraImport), intent(in) :: self - integer(C_SIZE_T) :: fresult type(SwigClassWrapper) :: farg1 @@ -5228,7 +5223,6 @@ function swigf_TpetraImport_getNumExportIDs(self) & use, intrinsic :: ISO_C_BINDING integer(C_SIZE_T) :: swig_result class(TpetraImport), intent(in) :: self - integer(C_SIZE_T) :: fresult type(SwigClassWrapper) :: farg1 @@ -5242,7 +5236,6 @@ function swigf_TpetraImport_getSourceMap(self) & use, intrinsic :: ISO_C_BINDING type(TpetraMap) :: swig_result class(TpetraImport), intent(in) :: self - type(SwigClassWrapper) :: fresult type(SwigClassWrapper) :: farg1 @@ -5256,7 +5249,6 @@ function swigf_TpetraImport_getTargetMap(self) & use, intrinsic :: ISO_C_BINDING type(TpetraMap) :: swig_result class(TpetraImport), intent(in) :: self - type(SwigClassWrapper) :: fresult type(SwigClassWrapper) :: farg1 @@ -5270,7 +5262,6 @@ function swigf_TpetraImport_isLocallyComplete(self) & use, intrinsic :: ISO_C_BINDING logical :: swig_result class(TpetraImport), intent(in) :: self - integer(C_INT) :: fresult type(SwigClassWrapper) :: farg1 @@ -5284,9 +5275,7 @@ function swigf_TpetraImport_setUnion__SWIG_0(self, rhs) & use, intrinsic :: ISO_C_BINDING type(TpetraImport) :: swig_result class(TpetraImport), intent(in) :: self - class(TpetraImport), intent(in) :: rhs - type(SwigClassWrapper) :: fresult type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 @@ -5302,7 +5291,6 @@ function swigf_TpetraImport_setUnion__SWIG_1(self) & use, intrinsic :: ISO_C_BINDING type(TpetraImport) :: swig_result class(TpetraImport), intent(in) :: self - type(SwigClassWrapper) :: fresult type(SwigClassWrapper) :: farg1 @@ -5316,9 +5304,7 @@ function swigf_TpetraImport_createRemoteOnlyImport(self, remotetarget) & use, intrinsic :: ISO_C_BINDING type(TpetraImport) :: swig_result class(TpetraImport), intent(in) :: self - class(TpetraMap), intent(in) :: remotetarget - type(SwigClassWrapper) :: fresult type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 @@ -5332,9 +5318,7 @@ function swigf_TpetraImport_createRemoteOnlyImport(self, remotetarget) & subroutine swigf_TpetraImport_print(self, os) use, intrinsic :: ISO_C_BINDING class(TpetraImport), intent(in) :: self - -class(SWIGTYPE_std__ostream), intent(inout) :: os - +class(SWIGTYPE_std__ostream), intent(in) :: os type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 @@ -5343,20 +5327,25 @@ subroutine swigf_TpetraImport_print(self, os) call swigc_TpetraImport_print(farg1, farg2) end subroutine - subroutine swigf_assignment_TpetraImport(self, other) - use, intrinsic :: ISO_C_BINDING - class(TpetraImport), intent(inout) :: self - type(TpetraImport), intent(in) :: other - call swigc_assignment_TpetraImport(self%swigdata, other%swigdata) - end subroutine -function new_TpetraExport__SWIG_0(source, target) & +subroutine swigf_TpetraImport_op_assign__(self, other) +use, intrinsic :: ISO_C_BINDING +class(TpetraImport), intent(inout) :: self +type(SWIGTYPE_Tpetra__ImportT_LO_GO_NO_t), intent(in) :: other +type(SwigClassWrapper) :: farg1 +type(SwigClassWrapper) :: farg2 + +farg1 = self%swigdata +farg2 = other%swigdata +call swigc_TpetraImport_op_assign__(farg1, farg2) +self%swigdata = farg1 +end subroutine + +function swigf_new_TpetraExport__SWIG_0(source, target) & result(self) use, intrinsic :: ISO_C_BINDING type(TpetraExport) :: self class(TpetraMap), intent(in) :: source - class(TpetraMap), intent(in) :: target - type(SwigClassWrapper) :: fresult type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 @@ -5367,16 +5356,13 @@ function new_TpetraExport__SWIG_0(source, target) & self%swigdata = fresult end function -function new_TpetraExport__SWIG_1(source, target, plist) & +function swigf_new_TpetraExport__SWIG_1(source, target, plist) & result(self) use, intrinsic :: ISO_C_BINDING type(TpetraExport) :: self class(TpetraMap), intent(in) :: source - class(TpetraMap), intent(in) :: target - class(ParameterList), intent(in) :: plist - type(SwigClassWrapper) :: fresult type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 @@ -5389,12 +5375,11 @@ function new_TpetraExport__SWIG_1(source, target, plist) & self%swigdata = fresult end function -function new_TpetraExport__SWIG_2(rhs) & +function swigf_new_TpetraExport__SWIG_2(rhs) & result(self) use, intrinsic :: ISO_C_BINDING type(TpetraExport) :: self class(TpetraExport), intent(in) :: rhs - type(SwigClassWrapper) :: fresult type(SwigClassWrapper) :: farg1 @@ -5403,12 +5388,11 @@ function new_TpetraExport__SWIG_2(rhs) & self%swigdata = fresult end function -function new_TpetraExport__SWIG_3(importer) & +function swigf_new_TpetraExport__SWIG_3(importer) & result(self) use, intrinsic :: ISO_C_BINDING type(TpetraExport) :: self class(TpetraImport), intent(in) :: importer - type(SwigClassWrapper) :: fresult type(SwigClassWrapper) :: farg1 @@ -5420,7 +5404,6 @@ function new_TpetraExport__SWIG_3(importer) & subroutine delete_TpetraExport(self) use, intrinsic :: ISO_C_BINDING class(TpetraExport), intent(inout) :: self - type(SwigClassWrapper) :: farg1 farg1 = self%swigdata @@ -5433,10 +5416,8 @@ subroutine delete_TpetraExport(self) subroutine swigf_TpetraExport_setParameterList(self, plist) use, intrinsic :: ISO_C_BINDING -class(TpetraExport), intent(inout) :: self - +class(TpetraExport), intent(in) :: self class(ParameterList), intent(in) :: plist - type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 @@ -5450,7 +5431,6 @@ function swigf_TpetraExport_getNumSameIDs(self) & use, intrinsic :: ISO_C_BINDING integer(C_SIZE_T) :: swig_result class(TpetraExport), intent(in) :: self - integer(C_SIZE_T) :: fresult type(SwigClassWrapper) :: farg1 @@ -5464,7 +5444,6 @@ function swigf_TpetraExport_getNumPermuteIDs(self) & use, intrinsic :: ISO_C_BINDING integer(C_SIZE_T) :: swig_result class(TpetraExport), intent(in) :: self - integer(C_SIZE_T) :: fresult type(SwigClassWrapper) :: farg1 @@ -5478,7 +5457,6 @@ function swigf_TpetraExport_getNumRemoteIDs(self) & use, intrinsic :: ISO_C_BINDING integer(C_SIZE_T) :: swig_result class(TpetraExport), intent(in) :: self - integer(C_SIZE_T) :: fresult type(SwigClassWrapper) :: farg1 @@ -5492,7 +5470,6 @@ function swigf_TpetraExport_getNumExportIDs(self) & use, intrinsic :: ISO_C_BINDING integer(C_SIZE_T) :: swig_result class(TpetraExport), intent(in) :: self - integer(C_SIZE_T) :: fresult type(SwigClassWrapper) :: farg1 @@ -5506,7 +5483,6 @@ function swigf_TpetraExport_getSourceMap(self) & use, intrinsic :: ISO_C_BINDING type(TpetraMap) :: swig_result class(TpetraExport), intent(in) :: self - type(SwigClassWrapper) :: fresult type(SwigClassWrapper) :: farg1 @@ -5520,7 +5496,6 @@ function swigf_TpetraExport_getTargetMap(self) & use, intrinsic :: ISO_C_BINDING type(TpetraMap) :: swig_result class(TpetraExport), intent(in) :: self - type(SwigClassWrapper) :: fresult type(SwigClassWrapper) :: farg1 @@ -5534,7 +5509,6 @@ function swigf_TpetraExport_isLocallyComplete(self) & use, intrinsic :: ISO_C_BINDING logical :: swig_result class(TpetraExport), intent(in) :: self - integer(C_INT) :: fresult type(SwigClassWrapper) :: farg1 @@ -5546,9 +5520,7 @@ function swigf_TpetraExport_isLocallyComplete(self) & subroutine swigf_TpetraExport_print(self, os) use, intrinsic :: ISO_C_BINDING class(TpetraExport), intent(in) :: self - -class(SWIGTYPE_std__ostream), intent(inout) :: os - +class(SWIGTYPE_std__ostream), intent(in) :: os type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 @@ -5557,17 +5529,23 @@ subroutine swigf_TpetraExport_print(self, os) call swigc_TpetraExport_print(farg1, farg2) end subroutine - subroutine swigf_assignment_TpetraExport(self, other) - use, intrinsic :: ISO_C_BINDING - class(TpetraExport), intent(inout) :: self - type(TpetraExport), intent(in) :: other - call swigc_assignment_TpetraExport(self%swigdata, other%swigdata) - end subroutine -function new_TpetraMultiVector__SWIG_0() & +subroutine swigf_TpetraExport_op_assign__(self, other) +use, intrinsic :: ISO_C_BINDING +class(TpetraExport), intent(inout) :: self +type(SWIGTYPE_Tpetra__ExportT_LO_GO_NO_t), intent(in) :: other +type(SwigClassWrapper) :: farg1 +type(SwigClassWrapper) :: farg2 + +farg1 = self%swigdata +farg2 = other%swigdata +call swigc_TpetraExport_op_assign__(farg1, farg2) +self%swigdata = farg1 +end subroutine + +function swigf_new_TpetraMultiVector__SWIG_0() & result(self) use, intrinsic :: ISO_C_BINDING type(TpetraMultiVector) :: self - type(SwigClassWrapper) :: fresult fresult = swigc_new_TpetraMultiVector__SWIG_0() @@ -5587,15 +5565,13 @@ function SWIG_logical_to_int(inp) & end if end function -function new_TpetraMultiVector__SWIG_1(map, numvecs, zeroout) & +function swigf_new_TpetraMultiVector__SWIG_1(map, numvecs, zeroout) & result(self) use, intrinsic :: ISO_C_BINDING type(TpetraMultiVector) :: self class(TpetraMap), intent(in) :: map - integer(C_SIZE_T), intent(in) :: numvecs logical, intent(in) :: zeroout - type(SwigClassWrapper) :: fresult type(SwigClassWrapper) :: farg1 integer(C_SIZE_T) :: farg2 @@ -5608,14 +5584,12 @@ function new_TpetraMultiVector__SWIG_1(map, numvecs, zeroout) & self%swigdata = fresult end function -function new_TpetraMultiVector__SWIG_2(map, numvecs) & +function swigf_new_TpetraMultiVector__SWIG_2(map, numvecs) & result(self) use, intrinsic :: ISO_C_BINDING type(TpetraMultiVector) :: self class(TpetraMap), intent(in) :: map - integer(C_SIZE_T), intent(in) :: numvecs - type(SwigClassWrapper) :: fresult type(SwigClassWrapper) :: farg1 integer(C_SIZE_T) :: farg2 @@ -5626,12 +5600,11 @@ function new_TpetraMultiVector__SWIG_2(map, numvecs) & self%swigdata = fresult end function -function new_TpetraMultiVector__SWIG_3(source) & +function swigf_new_TpetraMultiVector__SWIG_3(source) & result(self) use, intrinsic :: ISO_C_BINDING type(TpetraMultiVector) :: self class(TpetraMultiVector), intent(in) :: source - type(SwigClassWrapper) :: fresult type(SwigClassWrapper) :: farg1 @@ -5640,14 +5613,12 @@ function new_TpetraMultiVector__SWIG_3(source) & self%swigdata = fresult end function -function new_TpetraMultiVector__SWIG_4(source, copyorview) & +function swigf_new_TpetraMultiVector__SWIG_4(source, copyorview) & result(self) use, intrinsic :: ISO_C_BINDING type(TpetraMultiVector) :: self class(TpetraMultiVector), intent(in) :: source - integer(TeuchosDataAccess), intent(in) :: copyorview - type(SwigClassWrapper) :: fresult type(SwigClassWrapper) :: farg1 integer(C_INT) :: farg2 @@ -5658,17 +5629,15 @@ function new_TpetraMultiVector__SWIG_4(source, copyorview) & self%swigdata = fresult end function -function new_TpetraMultiVector__SWIG_5(map, a, lda, numvectors) & +function swigf_new_TpetraMultiVector__SWIG_5(map, a, lda, numvectors) & result(self) use, intrinsic :: ISO_C_BINDING type(TpetraMultiVector) :: self class(TpetraMap), intent(in) :: map - real(C_DOUBLE), dimension(:), target :: a real(C_DOUBLE), pointer :: farg2_view integer(C_SIZE_T), intent(in) :: lda integer(C_SIZE_T), intent(in) :: numvectors - type(SwigClassWrapper) :: fresult type(SwigClassWrapper) :: farg1 type(SwigArrayWrapper) :: farg2 @@ -5690,16 +5659,13 @@ function new_TpetraMultiVector__SWIG_5(map, a, lda, numvectors) & self%swigdata = fresult end function -function new_TpetraMultiVector__SWIG_7(x, submap, offset) & +function swigf_new_TpetraMultiVector__SWIG_7(x, submap, offset) & result(self) use, intrinsic :: ISO_C_BINDING type(TpetraMultiVector) :: self class(TpetraMultiVector), intent(in) :: x - class(TpetraMap), intent(in) :: submap - integer(C_SIZE_T), intent(in) :: offset - type(SwigClassWrapper) :: fresult type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 @@ -5712,14 +5678,12 @@ function new_TpetraMultiVector__SWIG_7(x, submap, offset) & self%swigdata = fresult end function -function new_TpetraMultiVector__SWIG_8(x, submap) & +function swigf_new_TpetraMultiVector__SWIG_8(x, submap) & result(self) use, intrinsic :: ISO_C_BINDING type(TpetraMultiVector) :: self class(TpetraMultiVector), intent(in) :: x - class(TpetraMap), intent(in) :: submap - type(SwigClassWrapper) :: fresult type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 @@ -5732,10 +5696,8 @@ function new_TpetraMultiVector__SWIG_8(x, submap) & subroutine swigf_TpetraMultiVector_swap(self, mv) use, intrinsic :: ISO_C_BINDING -class(TpetraMultiVector), intent(inout) :: self - -class(TpetraMultiVector), intent(inout) :: mv - +class(TpetraMultiVector), intent(in) :: self +class(TpetraMultiVector), intent(in) :: mv type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 @@ -5747,7 +5709,6 @@ subroutine swigf_TpetraMultiVector_swap(self, mv) subroutine delete_TpetraMultiVector(self) use, intrinsic :: ISO_C_BINDING class(TpetraMultiVector), intent(inout) :: self - type(SwigClassWrapper) :: farg1 farg1 = self%swigdata @@ -5761,11 +5722,9 @@ subroutine delete_TpetraMultiVector(self) subroutine swigf_TpetraMultiVector_replaceGlobalValue(self, gblrow, col, value) use, intrinsic :: ISO_C_BINDING class(TpetraMultiVector), intent(in) :: self - integer(C_LONG_LONG), intent(in) :: gblrow integer(C_SIZE_T), intent(in) :: col real(C_DOUBLE), intent(in) :: value - type(SwigClassWrapper) :: farg1 integer(C_LONG_LONG) :: farg2 integer(C_SIZE_T) :: farg3 @@ -5781,12 +5740,10 @@ subroutine swigf_TpetraMultiVector_replaceGlobalValue(self, gblrow, col, value) subroutine swigf_TpetraMultiVector_sumIntoGlobalValue__SWIG_0(self, gblrow, col, value, atomic) use, intrinsic :: ISO_C_BINDING class(TpetraMultiVector), intent(in) :: self - integer(C_LONG_LONG), intent(in) :: gblrow integer(C_SIZE_T), intent(in) :: col real(C_DOUBLE), intent(in) :: value logical, intent(in) :: atomic - type(SwigClassWrapper) :: farg1 integer(C_LONG_LONG) :: farg2 integer(C_SIZE_T) :: farg3 @@ -5804,11 +5761,9 @@ subroutine swigf_TpetraMultiVector_sumIntoGlobalValue__SWIG_0(self, gblrow, col, subroutine swigf_TpetraMultiVector_sumIntoGlobalValue__SWIG_1(self, gblrow, col, value) use, intrinsic :: ISO_C_BINDING class(TpetraMultiVector), intent(in) :: self - integer(C_LONG_LONG), intent(in) :: gblrow integer(C_SIZE_T), intent(in) :: col real(C_DOUBLE), intent(in) :: value - type(SwigClassWrapper) :: farg1 integer(C_LONG_LONG) :: farg2 integer(C_SIZE_T) :: farg3 @@ -5824,11 +5779,9 @@ subroutine swigf_TpetraMultiVector_sumIntoGlobalValue__SWIG_1(self, gblrow, col, subroutine swigf_TpetraMultiVector_replaceLocalValue(self, lclrow, col, value) use, intrinsic :: ISO_C_BINDING class(TpetraMultiVector), intent(in) :: self - integer, intent(in) :: lclrow integer(C_SIZE_T), intent(in) :: col real(C_DOUBLE), intent(in) :: value - type(SwigClassWrapper) :: farg1 integer(C_INT) :: farg2 integer(C_SIZE_T) :: farg3 @@ -5844,12 +5797,10 @@ subroutine swigf_TpetraMultiVector_replaceLocalValue(self, lclrow, col, value) subroutine swigf_TpetraMultiVector_sumIntoLocalValue__SWIG_0(self, lclrow, col, val, atomic) use, intrinsic :: ISO_C_BINDING class(TpetraMultiVector), intent(in) :: self - integer, intent(in) :: lclrow integer(C_SIZE_T), intent(in) :: col real(C_DOUBLE), intent(in) :: val logical, intent(in) :: atomic - type(SwigClassWrapper) :: farg1 integer(C_INT) :: farg2 integer(C_SIZE_T) :: farg3 @@ -5867,11 +5818,9 @@ subroutine swigf_TpetraMultiVector_sumIntoLocalValue__SWIG_0(self, lclrow, col, subroutine swigf_TpetraMultiVector_sumIntoLocalValue__SWIG_1(self, lclrow, col, val) use, intrinsic :: ISO_C_BINDING class(TpetraMultiVector), intent(in) :: self - integer, intent(in) :: lclrow integer(C_SIZE_T), intent(in) :: col real(C_DOUBLE), intent(in) :: val - type(SwigClassWrapper) :: farg1 integer(C_INT) :: farg2 integer(C_SIZE_T) :: farg3 @@ -5886,10 +5835,8 @@ subroutine swigf_TpetraMultiVector_sumIntoLocalValue__SWIG_1(self, lclrow, col, subroutine swigf_TpetraMultiVector_putScalar(self, value) use, intrinsic :: ISO_C_BINDING -class(TpetraMultiVector), intent(inout) :: self - +class(TpetraMultiVector), intent(in) :: self real(C_DOUBLE), intent(in) :: value - type(SwigClassWrapper) :: farg1 real(C_DOUBLE) :: farg2 @@ -5900,8 +5847,7 @@ subroutine swigf_TpetraMultiVector_putScalar(self, value) subroutine swigf_TpetraMultiVector_randomize__SWIG_0(self) use, intrinsic :: ISO_C_BINDING -class(TpetraMultiVector), intent(inout) :: self - +class(TpetraMultiVector), intent(in) :: self type(SwigClassWrapper) :: farg1 farg1 = self%swigdata @@ -5910,11 +5856,9 @@ subroutine swigf_TpetraMultiVector_randomize__SWIG_0(self) subroutine swigf_TpetraMultiVector_randomize__SWIG_1(self, minval, maxval) use, intrinsic :: ISO_C_BINDING -class(TpetraMultiVector), intent(inout) :: self - +class(TpetraMultiVector), intent(in) :: self real(C_DOUBLE), intent(in) :: minval real(C_DOUBLE), intent(in) :: maxval - type(SwigClassWrapper) :: farg1 real(C_DOUBLE) :: farg2 real(C_DOUBLE) :: farg3 @@ -5927,10 +5871,8 @@ subroutine swigf_TpetraMultiVector_randomize__SWIG_1(self, minval, maxval) subroutine swigf_TpetraMultiVector_replaceMap(self, map) use, intrinsic :: ISO_C_BINDING -class(TpetraMultiVector), intent(inout) :: self - +class(TpetraMultiVector), intent(in) :: self class(TpetraMap), intent(in) :: map - type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 @@ -5941,8 +5883,7 @@ subroutine swigf_TpetraMultiVector_replaceMap(self, map) subroutine swigf_TpetraMultiVector_reduce(self) use, intrinsic :: ISO_C_BINDING -class(TpetraMultiVector), intent(inout) :: self - +class(TpetraMultiVector), intent(in) :: self type(SwigClassWrapper) :: farg1 farg1 = self%swigdata @@ -5954,10 +5895,8 @@ function swigf_TpetraMultiVector_subCopy(self, cols) & use, intrinsic :: ISO_C_BINDING type(TpetraMultiVector) :: swig_result class(TpetraMultiVector), intent(in) :: self - integer(C_LONG), dimension(:), target :: cols integer(C_LONG), pointer :: farg2_view - type(SwigClassWrapper) :: fresult type(SwigClassWrapper) :: farg1 type(SwigArrayWrapper) :: farg2 @@ -5980,10 +5919,8 @@ function swigf_TpetraMultiVector_subView(self, cols) & use, intrinsic :: ISO_C_BINDING type(TpetraMultiVector) :: swig_result class(TpetraMultiVector), intent(in) :: self - integer(C_LONG), dimension(:), target :: cols integer(C_LONG), pointer :: farg2_view - type(SwigClassWrapper) :: fresult type(SwigClassWrapper) :: farg1 type(SwigArrayWrapper) :: farg2 @@ -6005,11 +5942,9 @@ function swigf_TpetraMultiVector_subViewNonConst(self, cols) & result(swig_result) use, intrinsic :: ISO_C_BINDING type(TpetraMultiVector) :: swig_result -class(TpetraMultiVector), intent(inout) :: self - +class(TpetraMultiVector), intent(in) :: self integer(C_LONG), dimension(:), target :: cols integer(C_LONG), pointer :: farg2_view - type(SwigClassWrapper) :: fresult type(SwigClassWrapper) :: farg1 type(SwigArrayWrapper) :: farg2 @@ -6032,11 +5967,8 @@ function swigf_TpetraMultiVector_offsetView(self, submap, offset) & use, intrinsic :: ISO_C_BINDING type(TpetraMultiVector) :: swig_result class(TpetraMultiVector), intent(in) :: self - class(TpetraMap), intent(in) :: submap - integer(C_SIZE_T), intent(in) :: offset - type(SwigClassWrapper) :: fresult type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 @@ -6053,12 +5985,9 @@ function swigf_TpetraMultiVector_offsetViewNonConst(self, submap, offset) & result(swig_result) use, intrinsic :: ISO_C_BINDING type(TpetraMultiVector) :: swig_result -class(TpetraMultiVector), intent(inout) :: self - +class(TpetraMultiVector), intent(in) :: self class(TpetraMap), intent(in) :: submap - integer(C_SIZE_T), intent(in) :: offset - type(SwigClassWrapper) :: fresult type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 @@ -6076,9 +6005,7 @@ function swigf_TpetraMultiVector_getData(self, j) & use, intrinsic :: ISO_C_BINDING real(C_DOUBLE), dimension(:), pointer :: swig_result class(TpetraMultiVector), intent(in) :: self - integer(C_SIZE_T), intent(in) :: j - type(SwigArrayWrapper) :: fresult type(SwigClassWrapper) :: farg1 integer(C_SIZE_T) :: farg2 @@ -6097,10 +6024,8 @@ function swigf_TpetraMultiVector_getDataNonConst(self, j) & result(swig_result) use, intrinsic :: ISO_C_BINDING real(C_DOUBLE), dimension(:), pointer :: swig_result -class(TpetraMultiVector), intent(inout) :: self - +class(TpetraMultiVector), intent(in) :: self integer(C_SIZE_T), intent(in) :: j - type(SwigArrayWrapper) :: fresult type(SwigClassWrapper) :: farg1 integer(C_SIZE_T) :: farg2 @@ -6118,11 +6043,9 @@ function swigf_TpetraMultiVector_getDataNonConst(self, j) & subroutine swigf_TpetraMultiVector_get1dCopy(self, a, lda) use, intrinsic :: ISO_C_BINDING class(TpetraMultiVector), intent(in) :: self - real(C_DOUBLE), dimension(:), target :: a real(C_DOUBLE), pointer :: farg2_view integer(C_SIZE_T), intent(in) :: lda - type(SwigClassWrapper) :: farg1 type(SwigArrayWrapper) :: farg2 integer(C_SIZE_T) :: farg3 @@ -6145,7 +6068,6 @@ function swigf_TpetraMultiVector_get1dView(self) & use, intrinsic :: ISO_C_BINDING real(C_DOUBLE), dimension(:), pointer :: swig_result class(TpetraMultiVector), intent(in) :: self - type(SwigArrayWrapper) :: fresult type(SwigClassWrapper) :: farg1 @@ -6162,8 +6084,7 @@ function swigf_TpetraMultiVector_get1dViewNonConst(self) & result(swig_result) use, intrinsic :: ISO_C_BINDING real(C_DOUBLE), dimension(:), pointer :: swig_result -class(TpetraMultiVector), intent(inout) :: self - +class(TpetraMultiVector), intent(in) :: self type(SwigArrayWrapper) :: fresult type(SwigClassWrapper) :: farg1 @@ -6178,8 +6099,7 @@ function swigf_TpetraMultiVector_get1dViewNonConst(self) & subroutine swigf_TpetraMultiVector_sync_host(self) use, intrinsic :: ISO_C_BINDING -class(TpetraMultiVector), intent(inout) :: self - +class(TpetraMultiVector), intent(in) :: self type(SwigClassWrapper) :: farg1 farg1 = self%swigdata @@ -6188,8 +6108,7 @@ subroutine swigf_TpetraMultiVector_sync_host(self) subroutine swigf_TpetraMultiVector_sync_device(self) use, intrinsic :: ISO_C_BINDING -class(TpetraMultiVector), intent(inout) :: self - +class(TpetraMultiVector), intent(in) :: self type(SwigClassWrapper) :: farg1 farg1 = self%swigdata @@ -6201,7 +6120,6 @@ function swigf_TpetraMultiVector_need_sync_host(self) & use, intrinsic :: ISO_C_BINDING logical :: swig_result class(TpetraMultiVector), intent(in) :: self - integer(C_INT) :: fresult type(SwigClassWrapper) :: farg1 @@ -6215,7 +6133,6 @@ function swigf_TpetraMultiVector_need_sync_device(self) & use, intrinsic :: ISO_C_BINDING logical :: swig_result class(TpetraMultiVector), intent(in) :: self - integer(C_INT) :: fresult type(SwigClassWrapper) :: farg1 @@ -6226,8 +6143,7 @@ function swigf_TpetraMultiVector_need_sync_device(self) & subroutine swigf_TpetraMultiVector_modify_device(self) use, intrinsic :: ISO_C_BINDING -class(TpetraMultiVector), intent(inout) :: self - +class(TpetraMultiVector), intent(in) :: self type(SwigClassWrapper) :: farg1 farg1 = self%swigdata @@ -6236,8 +6152,7 @@ subroutine swigf_TpetraMultiVector_modify_device(self) subroutine swigf_TpetraMultiVector_modify_host(self) use, intrinsic :: ISO_C_BINDING -class(TpetraMultiVector), intent(inout) :: self - +class(TpetraMultiVector), intent(in) :: self type(SwigClassWrapper) :: farg1 farg1 = self%swigdata @@ -6247,12 +6162,9 @@ subroutine swigf_TpetraMultiVector_modify_host(self) subroutine swigf_TpetraMultiVector_dot__SWIG_0(self, a, dots) use, intrinsic :: ISO_C_BINDING class(TpetraMultiVector), intent(in) :: self - class(TpetraMultiVector), intent(in) :: a - real(C_DOUBLE), dimension(:), target :: dots real(C_DOUBLE), pointer :: farg3_view - type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 type(SwigArrayWrapper) :: farg3 @@ -6273,11 +6185,8 @@ subroutine swigf_TpetraMultiVector_dot__SWIG_0(self, a, dots) subroutine swigf_TpetraMultiVector_dot__SWIG_3(self, a, norms) use, intrinsic :: ISO_C_BINDING class(TpetraMultiVector), intent(in) :: self - class(TpetraMultiVector), intent(in) :: a - class(SWIGTYPE_Kokkos__ViewT_double_p_Kokkos__HostSpace_t), intent(in) :: norms - type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 type(SwigClassWrapper) :: farg3 @@ -6290,10 +6199,8 @@ subroutine swigf_TpetraMultiVector_dot__SWIG_3(self, a, norms) subroutine swigf_TpetraMultiVector_abs(self, a) use, intrinsic :: ISO_C_BINDING -class(TpetraMultiVector), intent(inout) :: self - +class(TpetraMultiVector), intent(in) :: self class(TpetraMultiVector), intent(in) :: a - type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 @@ -6304,10 +6211,8 @@ subroutine swigf_TpetraMultiVector_abs(self, a) subroutine swigf_TpetraMultiVector_reciprocal(self, a) use, intrinsic :: ISO_C_BINDING -class(TpetraMultiVector), intent(inout) :: self - +class(TpetraMultiVector), intent(in) :: self class(TpetraMultiVector), intent(in) :: a - type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 @@ -6318,10 +6223,8 @@ subroutine swigf_TpetraMultiVector_reciprocal(self, a) subroutine swigf_TpetraMultiVector_scale__SWIG_0(self, alpha) use, intrinsic :: ISO_C_BINDING -class(TpetraMultiVector), intent(inout) :: self - +class(TpetraMultiVector), intent(in) :: self real(C_DOUBLE), intent(in) :: alpha - type(SwigClassWrapper) :: farg1 real(C_DOUBLE) :: farg2 @@ -6332,11 +6235,9 @@ subroutine swigf_TpetraMultiVector_scale__SWIG_0(self, alpha) subroutine swigf_TpetraMultiVector_scale__SWIG_1(self, alpha) use, intrinsic :: ISO_C_BINDING -class(TpetraMultiVector), intent(inout) :: self - +class(TpetraMultiVector), intent(in) :: self real(C_DOUBLE), dimension(:), target :: alpha real(C_DOUBLE), pointer :: farg2_view - type(SwigClassWrapper) :: farg1 type(SwigArrayWrapper) :: farg2 @@ -6354,11 +6255,9 @@ subroutine swigf_TpetraMultiVector_scale__SWIG_1(self, alpha) subroutine swigf_TpetraMultiVector_scale__SWIG_2(self, alpha, a) use, intrinsic :: ISO_C_BINDING -class(TpetraMultiVector), intent(inout) :: self - +class(TpetraMultiVector), intent(in) :: self real(C_DOUBLE), intent(in) :: alpha class(TpetraMultiVector), intent(in) :: a - type(SwigClassWrapper) :: farg1 real(C_DOUBLE) :: farg2 type(SwigClassWrapper) :: farg3 @@ -6371,13 +6270,10 @@ subroutine swigf_TpetraMultiVector_scale__SWIG_2(self, alpha, a) subroutine swigf_TpetraMultiVector_update__SWIG_0(self, alpha, a, beta) use, intrinsic :: ISO_C_BINDING -class(TpetraMultiVector), intent(inout) :: self - +class(TpetraMultiVector), intent(in) :: self real(C_DOUBLE), intent(in) :: alpha class(TpetraMultiVector), intent(in) :: a - real(C_DOUBLE), intent(in) :: beta - type(SwigClassWrapper) :: farg1 real(C_DOUBLE) :: farg2 type(SwigClassWrapper) :: farg3 @@ -6392,16 +6288,12 @@ subroutine swigf_TpetraMultiVector_update__SWIG_0(self, alpha, a, beta) subroutine swigf_TpetraMultiVector_update__SWIG_1(self, alpha, a, beta, b, gamma) use, intrinsic :: ISO_C_BINDING -class(TpetraMultiVector), intent(inout) :: self - +class(TpetraMultiVector), intent(in) :: self real(C_DOUBLE), intent(in) :: alpha class(TpetraMultiVector), intent(in) :: a - real(C_DOUBLE), intent(in) :: beta class(TpetraMultiVector), intent(in) :: b - real(C_DOUBLE), intent(in) :: gamma - type(SwigClassWrapper) :: farg1 real(C_DOUBLE) :: farg2 type(SwigClassWrapper) :: farg3 @@ -6421,9 +6313,7 @@ subroutine swigf_TpetraMultiVector_update__SWIG_1(self, alpha, a, beta, b, gamma subroutine swigf_TpetraMultiVector_norm1__SWIG_1(self, norms) use, intrinsic :: ISO_C_BINDING class(TpetraMultiVector), intent(in) :: self - class(SWIGTYPE_Kokkos__ViewT_double_p_Kokkos__HostSpace_t), intent(in) :: norms - type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 @@ -6435,10 +6325,8 @@ subroutine swigf_TpetraMultiVector_norm1__SWIG_1(self, norms) subroutine swigf_TpetraMultiVector_norm1__SWIG_3(self, norms) use, intrinsic :: ISO_C_BINDING class(TpetraMultiVector), intent(in) :: self - real(C_DOUBLE), dimension(:), target :: norms real(C_DOUBLE), pointer :: farg2_view - type(SwigClassWrapper) :: farg1 type(SwigArrayWrapper) :: farg2 @@ -6457,9 +6345,7 @@ subroutine swigf_TpetraMultiVector_norm1__SWIG_3(self, norms) subroutine swigf_TpetraMultiVector_norm2__SWIG_1(self, norms) use, intrinsic :: ISO_C_BINDING class(TpetraMultiVector), intent(in) :: self - class(SWIGTYPE_Kokkos__ViewT_double_p_Kokkos__HostSpace_t), intent(in) :: norms - type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 @@ -6471,10 +6357,8 @@ subroutine swigf_TpetraMultiVector_norm2__SWIG_1(self, norms) subroutine swigf_TpetraMultiVector_norm2__SWIG_3(self, norms) use, intrinsic :: ISO_C_BINDING class(TpetraMultiVector), intent(in) :: self - real(C_DOUBLE), dimension(:), target :: norms real(C_DOUBLE), pointer :: farg2_view - type(SwigClassWrapper) :: farg1 type(SwigArrayWrapper) :: farg2 @@ -6493,9 +6377,7 @@ subroutine swigf_TpetraMultiVector_norm2__SWIG_3(self, norms) subroutine swigf_TpetraMultiVector_normInf__SWIG_1(self, norms) use, intrinsic :: ISO_C_BINDING class(TpetraMultiVector), intent(in) :: self - class(SWIGTYPE_Kokkos__ViewT_double_p_Kokkos__HostSpace_t), intent(in) :: norms - type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 @@ -6507,10 +6389,8 @@ subroutine swigf_TpetraMultiVector_normInf__SWIG_1(self, norms) subroutine swigf_TpetraMultiVector_normInf__SWIG_3(self, norms) use, intrinsic :: ISO_C_BINDING class(TpetraMultiVector), intent(in) :: self - real(C_DOUBLE), dimension(:), target :: norms real(C_DOUBLE), pointer :: farg2_view - type(SwigClassWrapper) :: farg1 type(SwigArrayWrapper) :: farg2 @@ -6529,10 +6409,8 @@ subroutine swigf_TpetraMultiVector_normInf__SWIG_3(self, norms) subroutine swigf_TpetraMultiVector_meanValue(self, means) use, intrinsic :: ISO_C_BINDING class(TpetraMultiVector), intent(in) :: self - real(C_DOUBLE), dimension(:), target :: means real(C_DOUBLE), pointer :: farg2_view - type(SwigClassWrapper) :: farg1 type(SwigArrayWrapper) :: farg2 @@ -6550,17 +6428,13 @@ subroutine swigf_TpetraMultiVector_meanValue(self, means) subroutine swigf_TpetraMultiVector_multiply(self, transa, transb, alpha, a, b, beta) use, intrinsic :: ISO_C_BINDING -class(TpetraMultiVector), intent(inout) :: self - +class(TpetraMultiVector), intent(in) :: self integer(TeuchosETransp), intent(in) :: transa integer(TeuchosETransp), intent(in) :: transb real(C_DOUBLE), intent(in) :: alpha class(TpetraMultiVector), intent(in) :: a - class(TpetraMultiVector), intent(in) :: b - real(C_DOUBLE), intent(in) :: beta - type(SwigClassWrapper) :: farg1 integer(C_INT) :: farg2 integer(C_INT) :: farg3 @@ -6584,7 +6458,6 @@ function swigf_TpetraMultiVector_getNumVectors(self) & use, intrinsic :: ISO_C_BINDING integer(C_SIZE_T) :: swig_result class(TpetraMultiVector), intent(in) :: self - integer(C_SIZE_T) :: fresult type(SwigClassWrapper) :: farg1 @@ -6598,7 +6471,6 @@ function swigf_TpetraMultiVector_getLocalLength(self) & use, intrinsic :: ISO_C_BINDING integer :: swig_result class(TpetraMultiVector), intent(in) :: self - integer(C_INT) :: fresult type(SwigClassWrapper) :: farg1 @@ -6612,7 +6484,6 @@ function swigf_TpetraMultiVector_getGlobalLength(self) & use, intrinsic :: ISO_C_BINDING integer(C_LONG) :: swig_result class(TpetraMultiVector), intent(in) :: self - integer(C_LONG) :: fresult type(SwigClassWrapper) :: farg1 @@ -6626,7 +6497,6 @@ function swigf_TpetraMultiVector_getStride(self) & use, intrinsic :: ISO_C_BINDING integer(C_SIZE_T) :: swig_result class(TpetraMultiVector), intent(in) :: self - integer(C_SIZE_T) :: fresult type(SwigClassWrapper) :: farg1 @@ -6640,7 +6510,6 @@ function swigf_TpetraMultiVector_isConstantStride(self) & use, intrinsic :: ISO_C_BINDING logical :: swig_result class(TpetraMultiVector), intent(in) :: self - integer(C_INT) :: fresult type(SwigClassWrapper) :: farg1 @@ -6654,7 +6523,6 @@ function swigf_TpetraMultiVector_description(self) & use, intrinsic :: ISO_C_BINDING character(kind=C_CHAR, len=:), allocatable :: swig_result class(TpetraMultiVector), intent(in) :: self - type(SwigArrayWrapper) :: fresult type(SwigClassWrapper) :: farg1 @@ -6666,10 +6534,8 @@ function swigf_TpetraMultiVector_description(self) & subroutine swigf_TpetraMultiVector_removeEmptyProcessesInPlace(self, newmap) use, intrinsic :: ISO_C_BINDING -class(TpetraMultiVector), intent(inout) :: self - +class(TpetraMultiVector), intent(in) :: self class(TpetraMap), intent(in) :: newmap - type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 @@ -6680,10 +6546,8 @@ subroutine swigf_TpetraMultiVector_removeEmptyProcessesInPlace(self, newmap) subroutine swigf_TpetraMultiVector_setCopyOrView(self, copyorview) use, intrinsic :: ISO_C_BINDING -class(TpetraMultiVector), intent(inout) :: self - +class(TpetraMultiVector), intent(in) :: self integer(TeuchosDataAccess), intent(in) :: copyorview - type(SwigClassWrapper) :: farg1 integer(C_INT) :: farg2 @@ -6697,7 +6561,6 @@ function swigf_TpetraMultiVector_getCopyOrView(self) & use, intrinsic :: ISO_C_BINDING integer(TeuchosDataAccess) :: swig_result class(TpetraMultiVector), intent(in) :: self - integer(C_INT) :: fresult type(SwigClassWrapper) :: farg1 @@ -6711,9 +6574,7 @@ function swigf_TpetraMultiVector_isSameSize(self, vec) & use, intrinsic :: ISO_C_BINDING logical :: swig_result class(TpetraMultiVector), intent(in) :: self - class(TpetraMultiVector), intent(in) :: vec - integer(C_INT) :: fresult type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 @@ -6726,14 +6587,10 @@ function swigf_TpetraMultiVector_isSameSize(self, vec) & subroutine swigf_TpetraMultiVector_doImport__SWIG_0(self, source, importer, cm) use, intrinsic :: ISO_C_BINDING -class(TpetraMultiVector), intent(inout) :: self - +class(TpetraMultiVector), intent(in) :: self class(TpetraMultiVector), intent(in) :: source - class(TpetraImport), intent(in) :: importer - integer(TpetraCombineMode), intent(in) :: cm - type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 type(SwigClassWrapper) :: farg3 @@ -6748,14 +6605,10 @@ subroutine swigf_TpetraMultiVector_doImport__SWIG_0(self, source, importer, cm) subroutine swigf_TpetraMultiVector_doImport__SWIG_1(self, source, exporter, cm) use, intrinsic :: ISO_C_BINDING -class(TpetraMultiVector), intent(inout) :: self - +class(TpetraMultiVector), intent(in) :: self class(TpetraMultiVector), intent(in) :: source - class(TpetraExport), intent(in) :: exporter - integer(TpetraCombineMode), intent(in) :: cm - type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 type(SwigClassWrapper) :: farg3 @@ -6770,14 +6623,10 @@ subroutine swigf_TpetraMultiVector_doImport__SWIG_1(self, source, exporter, cm) subroutine swigf_TpetraMultiVector_doExport__SWIG_0(self, source, exporter, cm) use, intrinsic :: ISO_C_BINDING -class(TpetraMultiVector), intent(inout) :: self - +class(TpetraMultiVector), intent(in) :: self class(TpetraMultiVector), intent(in) :: source - class(TpetraExport), intent(in) :: exporter - integer(TpetraCombineMode), intent(in) :: cm - type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 type(SwigClassWrapper) :: farg3 @@ -6792,14 +6641,10 @@ subroutine swigf_TpetraMultiVector_doExport__SWIG_0(self, source, exporter, cm) subroutine swigf_TpetraMultiVector_doExport__SWIG_1(self, source, importer, cm) use, intrinsic :: ISO_C_BINDING -class(TpetraMultiVector), intent(inout) :: self - +class(TpetraMultiVector), intent(in) :: self class(TpetraMultiVector), intent(in) :: source - class(TpetraImport), intent(in) :: importer - integer(TpetraCombineMode), intent(in) :: cm - type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 type(SwigClassWrapper) :: farg3 @@ -6812,16 +6657,22 @@ subroutine swigf_TpetraMultiVector_doExport__SWIG_1(self, source, importer, cm) call swigc_TpetraMultiVector_doExport__SWIG_1(farg1, farg2, farg3, farg4) end subroutine - subroutine swigf_assignment_TpetraMultiVector(self, other) - use, intrinsic :: ISO_C_BINDING - class(TpetraMultiVector), intent(inout) :: self - type(TpetraMultiVector), intent(in) :: other - call swigc_assignment_TpetraMultiVector(self%swigdata, other%swigdata) - end subroutine +subroutine swigf_TpetraMultiVector_op_assign__(self, other) +use, intrinsic :: ISO_C_BINDING +class(TpetraMultiVector), intent(inout) :: self +type(SWIGTYPE_Tpetra__MultiVectorT_SC_LO_GO_NO_t), intent(in) :: other +type(SwigClassWrapper) :: farg1 +type(SwigClassWrapper) :: farg2 + +farg1 = self%swigdata +farg2 = other%swigdata +call swigc_TpetraMultiVector_op_assign__(farg1, farg2) +self%swigdata = farg1 +end subroutine + subroutine delete_TpetraOperator(self) use, intrinsic :: ISO_C_BINDING class(TpetraOperator), intent(inout) :: self - type(SwigClassWrapper) :: farg1 farg1 = self%swigdata @@ -6832,18 +6683,24 @@ subroutine delete_TpetraOperator(self) self%swigdata%mem = SWIG_NULL end subroutine - subroutine swigf_assignment_TpetraOperator(self, other) - use, intrinsic :: ISO_C_BINDING - class(TpetraOperator), intent(inout) :: self - type(TpetraOperator), intent(in) :: other - call swigc_assignment_TpetraOperator(self%swigdata, other%swigdata) - end subroutine +subroutine swigf_TpetraOperator_op_assign__(self, other) +use, intrinsic :: ISO_C_BINDING +class(TpetraOperator), intent(inout) :: self +type(SWIGTYPE_Tpetra__OperatorT_SC_LO_GO_NO_t), intent(in) :: other +type(SwigClassWrapper) :: farg1 +type(SwigClassWrapper) :: farg2 + +farg1 = self%swigdata +farg2 = other%swigdata +call swigc_TpetraOperator_op_assign__(farg1, farg2) +self%swigdata = farg1 +end subroutine + function swigf_ForTpetraOperator_fhandle(self) & result(swig_result) use, intrinsic :: ISO_C_BINDING type(C_PTR) :: swig_result class(ForTpetraOperator), intent(in) :: self - type(C_PTR) :: fresult type(SwigClassWrapper) :: farg1 @@ -6854,10 +6711,8 @@ function swigf_ForTpetraOperator_fhandle(self) & subroutine swigf_ForTpetraOperator_init(self, fh) use, intrinsic :: ISO_C_BINDING -class(ForTpetraOperator), intent(inout) :: self - +class(ForTpetraOperator), intent(in) :: self type(C_PTR) :: fh - type(SwigClassWrapper) :: farg1 type(C_PTR) :: farg2 @@ -6870,7 +6725,6 @@ function new_ForTpetraOperator() & result(self) use, intrinsic :: ISO_C_BINDING type(ForTpetraOperator) :: self - type(SwigClassWrapper) :: fresult fresult = swigc_new_ForTpetraOperator() @@ -6882,7 +6736,6 @@ function swigf_ForTpetraOperator_getDomainMap(self) & use, intrinsic :: ISO_C_BINDING type(TpetraMap) :: swig_result class(ForTpetraOperator), intent(in) :: self - type(SwigClassWrapper) :: fresult type(SwigClassWrapper) :: farg1 @@ -6896,7 +6749,6 @@ function swigf_ForTpetraOperator_getRangeMap(self) & use, intrinsic :: ISO_C_BINDING type(TpetraMap) :: swig_result class(ForTpetraOperator), intent(in) :: self - type(SwigClassWrapper) :: fresult type(SwigClassWrapper) :: farg1 @@ -6908,15 +6760,11 @@ function swigf_ForTpetraOperator_getRangeMap(self) & subroutine swigf_ForTpetraOperator_apply(self, x, y, mode, alpha, beta) use, intrinsic :: ISO_C_BINDING class(ForTpetraOperator), intent(in) :: self - class(TpetraMultiVector), intent(in) :: x - -class(TpetraMultiVector), intent(inout) :: y - +class(TpetraMultiVector), intent(in) :: y integer(TeuchosETransp), intent(in) :: mode real(C_DOUBLE), intent(in) :: alpha real(C_DOUBLE), intent(in) :: beta - type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 type(SwigClassWrapper) :: farg3 @@ -6936,7 +6784,6 @@ subroutine swigf_ForTpetraOperator_apply(self, x, y, mode, alpha, beta) subroutine delete_ForTpetraOperator(self) use, intrinsic :: ISO_C_BINDING class(ForTpetraOperator), intent(inout) :: self - type(SwigClassWrapper) :: farg1 @@ -6955,12 +6802,19 @@ subroutine delete_ForTpetraOperator(self) deallocate(handle) end subroutine - subroutine swigf_assignment_ForTpetraOperator(self, other) - use, intrinsic :: ISO_C_BINDING - class(ForTpetraOperator), intent(inout) :: self - type(ForTpetraOperator), intent(in) :: other - call swigc_assignment_ForTpetraOperator(self%swigdata, other%swigdata) - end subroutine +subroutine swigf_ForTpetraOperator_op_assign__(self, other) +use, intrinsic :: ISO_C_BINDING +class(ForTpetraOperator), intent(inout) :: self +type(ForTpetraOperator), intent(in) :: other +type(SwigClassWrapper) :: farg1 +type(SwigClassWrapper) :: farg2 + +farg1 = self%swigdata +farg2 = other%swigdata +call swigc_ForTpetraOperator_op_assign__(farg1, farg2) +self%swigdata = farg1 +end subroutine + ! Convert a ISO-C class pointer struct into a user Fortran native pointer subroutine c_f_pointer_ForTpetraOperator(clswrap, fptr) @@ -7069,12 +6923,10 @@ subroutine init_ForTpetraOperator(self) call swigc_ForTpetraOperator_init(self%swigdata, c_loc(handle)) end subroutine -subroutine RowInfo_localRow_set(self, localrow) +subroutine swigf_RowInfo_localRow_set(self, localrow) use, intrinsic :: ISO_C_BINDING -class(RowInfo), intent(inout) :: self - +class(RowInfo), intent(in) :: self integer(C_SIZE_T), intent(in) :: localrow - type(SwigClassWrapper) :: farg1 integer(C_SIZE_T) :: farg2 @@ -7083,12 +6935,11 @@ subroutine RowInfo_localRow_set(self, localrow) call swigc_RowInfo_localRow_set(farg1, farg2) end subroutine -function RowInfo_localRow_get(self) & +function swigf_RowInfo_localRow_get(self) & result(swig_result) use, intrinsic :: ISO_C_BINDING integer(C_SIZE_T) :: swig_result -class(RowInfo), intent(inout) :: self - +class(RowInfo), intent(in) :: self integer(C_SIZE_T) :: fresult type(SwigClassWrapper) :: farg1 @@ -7097,12 +6948,10 @@ function RowInfo_localRow_get(self) & swig_result = fresult end function -subroutine RowInfo_allocSize_set(self, allocsize) +subroutine swigf_RowInfo_allocSize_set(self, allocsize) use, intrinsic :: ISO_C_BINDING -class(RowInfo), intent(inout) :: self - +class(RowInfo), intent(in) :: self integer(C_SIZE_T), intent(in) :: allocsize - type(SwigClassWrapper) :: farg1 integer(C_SIZE_T) :: farg2 @@ -7111,12 +6960,11 @@ subroutine RowInfo_allocSize_set(self, allocsize) call swigc_RowInfo_allocSize_set(farg1, farg2) end subroutine -function RowInfo_allocSize_get(self) & +function swigf_RowInfo_allocSize_get(self) & result(swig_result) use, intrinsic :: ISO_C_BINDING integer(C_SIZE_T) :: swig_result -class(RowInfo), intent(inout) :: self - +class(RowInfo), intent(in) :: self integer(C_SIZE_T) :: fresult type(SwigClassWrapper) :: farg1 @@ -7125,12 +6973,10 @@ function RowInfo_allocSize_get(self) & swig_result = fresult end function -subroutine RowInfo_numEntries_set(self, numentries) +subroutine swigf_RowInfo_numEntries_set(self, numentries) use, intrinsic :: ISO_C_BINDING -class(RowInfo), intent(inout) :: self - +class(RowInfo), intent(in) :: self integer(C_SIZE_T), intent(in) :: numentries - type(SwigClassWrapper) :: farg1 integer(C_SIZE_T) :: farg2 @@ -7139,12 +6985,11 @@ subroutine RowInfo_numEntries_set(self, numentries) call swigc_RowInfo_numEntries_set(farg1, farg2) end subroutine -function RowInfo_numEntries_get(self) & +function swigf_RowInfo_numEntries_get(self) & result(swig_result) use, intrinsic :: ISO_C_BINDING integer(C_SIZE_T) :: swig_result -class(RowInfo), intent(inout) :: self - +class(RowInfo), intent(in) :: self integer(C_SIZE_T) :: fresult type(SwigClassWrapper) :: farg1 @@ -7153,12 +6998,10 @@ function RowInfo_numEntries_get(self) & swig_result = fresult end function -subroutine RowInfo_offset1D_set(self, offset1d) +subroutine swigf_RowInfo_offset1D_set(self, offset1d) use, intrinsic :: ISO_C_BINDING -class(RowInfo), intent(inout) :: self - +class(RowInfo), intent(in) :: self integer(C_SIZE_T), intent(in) :: offset1d - type(SwigClassWrapper) :: farg1 integer(C_SIZE_T) :: farg2 @@ -7167,12 +7010,11 @@ subroutine RowInfo_offset1D_set(self, offset1d) call swigc_RowInfo_offset1D_set(farg1, farg2) end subroutine -function RowInfo_offset1D_get(self) & +function swigf_RowInfo_offset1D_get(self) & result(swig_result) use, intrinsic :: ISO_C_BINDING integer(C_SIZE_T) :: swig_result -class(RowInfo), intent(inout) :: self - +class(RowInfo), intent(in) :: self integer(C_SIZE_T) :: fresult type(SwigClassWrapper) :: farg1 @@ -7185,7 +7027,6 @@ function new_RowInfo() & result(self) use, intrinsic :: ISO_C_BINDING type(RowInfo) :: self - type(SwigClassWrapper) :: fresult fresult = swigc_new_RowInfo() @@ -7195,7 +7036,6 @@ function new_RowInfo() & subroutine delete_RowInfo(self) use, intrinsic :: ISO_C_BINDING class(RowInfo), intent(inout) :: self - type(SwigClassWrapper) :: farg1 farg1 = self%swigdata @@ -7206,22 +7046,27 @@ subroutine delete_RowInfo(self) self%swigdata%mem = SWIG_NULL end subroutine - subroutine swigf_assignment_RowInfo(self, other) - use, intrinsic :: ISO_C_BINDING - class(RowInfo), intent(inout) :: self - type(RowInfo), intent(in) :: other - call swigc_assignment_RowInfo(self%swigdata, other%swigdata) - end subroutine -function new_TpetraCrsGraph__SWIG_0(rowmap, maxnumentriesperrow, pftype, params) & +subroutine swigf_RowInfo_op_assign__(self, other) +use, intrinsic :: ISO_C_BINDING +class(RowInfo), intent(inout) :: self +type(RowInfo), intent(in) :: other +type(SwigClassWrapper) :: farg1 +type(SwigClassWrapper) :: farg2 + +farg1 = self%swigdata +farg2 = other%swigdata +call swigc_RowInfo_op_assign__(farg1, farg2) +self%swigdata = farg1 +end subroutine + +function swigf_new_TpetraCrsGraph__SWIG_0(rowmap, maxnumentriesperrow, pftype, params) & result(self) use, intrinsic :: ISO_C_BINDING type(TpetraCrsGraph) :: self class(TpetraMap), intent(in) :: rowmap - integer(C_SIZE_T), intent(in) :: maxnumentriesperrow integer(TpetraProfileType), intent(in) :: pftype class(ParameterList), intent(in) :: params - type(SwigClassWrapper) :: fresult type(SwigClassWrapper) :: farg1 integer(C_SIZE_T) :: farg2 @@ -7236,15 +7081,13 @@ function new_TpetraCrsGraph__SWIG_0(rowmap, maxnumentriesperrow, pftype, params) self%swigdata = fresult end function -function new_TpetraCrsGraph__SWIG_1(rowmap, maxnumentriesperrow, pftype) & +function swigf_new_TpetraCrsGraph__SWIG_1(rowmap, maxnumentriesperrow, pftype) & result(self) use, intrinsic :: ISO_C_BINDING type(TpetraCrsGraph) :: self class(TpetraMap), intent(in) :: rowmap - integer(C_SIZE_T), intent(in) :: maxnumentriesperrow integer(TpetraProfileType), intent(in) :: pftype - type(SwigClassWrapper) :: fresult type(SwigClassWrapper) :: farg1 integer(C_SIZE_T) :: farg2 @@ -7257,14 +7100,12 @@ function new_TpetraCrsGraph__SWIG_1(rowmap, maxnumentriesperrow, pftype) & self%swigdata = fresult end function -function new_TpetraCrsGraph__SWIG_2(rowmap, maxnumentriesperrow) & +function swigf_new_TpetraCrsGraph__SWIG_2(rowmap, maxnumentriesperrow) & result(self) use, intrinsic :: ISO_C_BINDING type(TpetraCrsGraph) :: self class(TpetraMap), intent(in) :: rowmap - integer(C_SIZE_T), intent(in) :: maxnumentriesperrow - type(SwigClassWrapper) :: fresult type(SwigClassWrapper) :: farg1 integer(C_SIZE_T) :: farg2 @@ -7275,17 +7116,15 @@ function new_TpetraCrsGraph__SWIG_2(rowmap, maxnumentriesperrow) & self%swigdata = fresult end function -function new_TpetraCrsGraph__SWIG_3(rowmap, numentperrow, pftype, params) & +function swigf_new_TpetraCrsGraph__SWIG_3(rowmap, numentperrow, pftype, params) & result(self) use, intrinsic :: ISO_C_BINDING type(TpetraCrsGraph) :: self class(TpetraMap), intent(in) :: rowmap - integer(C_LONG), dimension(:), target :: numentperrow integer(C_LONG), pointer :: farg2_view integer(TpetraProfileType), intent(in) :: pftype class(ParameterList), intent(in) :: params - type(SwigClassWrapper) :: fresult type(SwigClassWrapper) :: farg1 type(SwigArrayWrapper) :: farg2 @@ -7307,16 +7146,14 @@ function new_TpetraCrsGraph__SWIG_3(rowmap, numentperrow, pftype, params) & self%swigdata = fresult end function -function new_TpetraCrsGraph__SWIG_4(rowmap, numentperrow, pftype) & +function swigf_new_TpetraCrsGraph__SWIG_4(rowmap, numentperrow, pftype) & result(self) use, intrinsic :: ISO_C_BINDING type(TpetraCrsGraph) :: self class(TpetraMap), intent(in) :: rowmap - integer(C_LONG), dimension(:), target :: numentperrow integer(C_LONG), pointer :: farg2_view integer(TpetraProfileType), intent(in) :: pftype - type(SwigClassWrapper) :: fresult type(SwigClassWrapper) :: farg1 type(SwigArrayWrapper) :: farg2 @@ -7336,15 +7173,13 @@ function new_TpetraCrsGraph__SWIG_4(rowmap, numentperrow, pftype) & self%swigdata = fresult end function -function new_TpetraCrsGraph__SWIG_5(rowmap, numentperrow) & +function swigf_new_TpetraCrsGraph__SWIG_5(rowmap, numentperrow) & result(self) use, intrinsic :: ISO_C_BINDING type(TpetraCrsGraph) :: self class(TpetraMap), intent(in) :: rowmap - integer(C_LONG), dimension(:), target :: numentperrow integer(C_LONG), pointer :: farg2_view - type(SwigClassWrapper) :: fresult type(SwigClassWrapper) :: farg1 type(SwigArrayWrapper) :: farg2 @@ -7362,18 +7197,15 @@ function new_TpetraCrsGraph__SWIG_5(rowmap, numentperrow) & self%swigdata = fresult end function -function new_TpetraCrsGraph__SWIG_6(rowmap, colmap, maxnumentriesperrow, pftype, params) & +function swigf_new_TpetraCrsGraph__SWIG_6(rowmap, colmap, maxnumentriesperrow, pftype, params) & result(self) use, intrinsic :: ISO_C_BINDING type(TpetraCrsGraph) :: self class(TpetraMap), intent(in) :: rowmap - class(TpetraMap), intent(in) :: colmap - integer(C_SIZE_T), intent(in) :: maxnumentriesperrow integer(TpetraProfileType), intent(in) :: pftype class(ParameterList), intent(in) :: params - type(SwigClassWrapper) :: fresult type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 @@ -7390,17 +7222,14 @@ function new_TpetraCrsGraph__SWIG_6(rowmap, colmap, maxnumentriesperrow, pftype, self%swigdata = fresult end function -function new_TpetraCrsGraph__SWIG_7(rowmap, colmap, maxnumentriesperrow, pftype) & +function swigf_new_TpetraCrsGraph__SWIG_7(rowmap, colmap, maxnumentriesperrow, pftype) & result(self) use, intrinsic :: ISO_C_BINDING type(TpetraCrsGraph) :: self class(TpetraMap), intent(in) :: rowmap - class(TpetraMap), intent(in) :: colmap - integer(C_SIZE_T), intent(in) :: maxnumentriesperrow integer(TpetraProfileType), intent(in) :: pftype - type(SwigClassWrapper) :: fresult type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 @@ -7415,16 +7244,13 @@ function new_TpetraCrsGraph__SWIG_7(rowmap, colmap, maxnumentriesperrow, pftype) self%swigdata = fresult end function -function new_TpetraCrsGraph__SWIG_8(rowmap, colmap, maxnumentriesperrow) & +function swigf_new_TpetraCrsGraph__SWIG_8(rowmap, colmap, maxnumentriesperrow) & result(self) use, intrinsic :: ISO_C_BINDING type(TpetraCrsGraph) :: self class(TpetraMap), intent(in) :: rowmap - class(TpetraMap), intent(in) :: colmap - integer(C_SIZE_T), intent(in) :: maxnumentriesperrow - type(SwigClassWrapper) :: fresult type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 @@ -7437,19 +7263,16 @@ function new_TpetraCrsGraph__SWIG_8(rowmap, colmap, maxnumentriesperrow) & self%swigdata = fresult end function -function new_TpetraCrsGraph__SWIG_9(rowmap, colmap, numentperrow, pftype, params) & +function swigf_new_TpetraCrsGraph__SWIG_9(rowmap, colmap, numentperrow, pftype, params) & result(self) use, intrinsic :: ISO_C_BINDING type(TpetraCrsGraph) :: self class(TpetraMap), intent(in) :: rowmap - class(TpetraMap), intent(in) :: colmap - integer(C_LONG), dimension(:), target :: numentperrow integer(C_LONG), pointer :: farg3_view integer(TpetraProfileType), intent(in) :: pftype class(ParameterList), intent(in) :: params - type(SwigClassWrapper) :: fresult type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 @@ -7473,18 +7296,15 @@ function new_TpetraCrsGraph__SWIG_9(rowmap, colmap, numentperrow, pftype, params self%swigdata = fresult end function -function new_TpetraCrsGraph__SWIG_10(rowmap, colmap, numentperrow, pftype) & +function swigf_new_TpetraCrsGraph__SWIG_10(rowmap, colmap, numentperrow, pftype) & result(self) use, intrinsic :: ISO_C_BINDING type(TpetraCrsGraph) :: self class(TpetraMap), intent(in) :: rowmap - class(TpetraMap), intent(in) :: colmap - integer(C_LONG), dimension(:), target :: numentperrow integer(C_LONG), pointer :: farg3_view integer(TpetraProfileType), intent(in) :: pftype - type(SwigClassWrapper) :: fresult type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 @@ -7506,17 +7326,14 @@ function new_TpetraCrsGraph__SWIG_10(rowmap, colmap, numentperrow, pftype) & self%swigdata = fresult end function -function new_TpetraCrsGraph__SWIG_11(rowmap, colmap, numentperrow) & +function swigf_new_TpetraCrsGraph__SWIG_11(rowmap, colmap, numentperrow) & result(self) use, intrinsic :: ISO_C_BINDING type(TpetraCrsGraph) :: self class(TpetraMap), intent(in) :: rowmap - class(TpetraMap), intent(in) :: colmap - integer(C_LONG), dimension(:), target :: numentperrow integer(C_LONG), pointer :: farg3_view - type(SwigClassWrapper) :: fresult type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 @@ -7536,20 +7353,17 @@ function new_TpetraCrsGraph__SWIG_11(rowmap, colmap, numentperrow) & self%swigdata = fresult end function -function new_TpetraCrsGraph__SWIG_12(rowmap, colmap, rowpointers, columnindices, params) & +function swigf_new_TpetraCrsGraph__SWIG_12(rowmap, colmap, rowpointers, columnindices, params) & result(self) use, intrinsic :: ISO_C_BINDING type(TpetraCrsGraph) :: self class(TpetraMap), intent(in) :: rowmap - class(TpetraMap), intent(in) :: colmap - integer(C_LONG), dimension(:), target :: rowpointers integer(C_LONG), pointer :: farg3_view integer(C_INT), dimension(:), target :: columnindices integer(C_INT), pointer :: farg4_view class(ParameterList), intent(in) :: params - type(SwigClassWrapper) :: fresult type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 @@ -7580,19 +7394,16 @@ function new_TpetraCrsGraph__SWIG_12(rowmap, colmap, rowpointers, columnindices, self%swigdata = fresult end function -function new_TpetraCrsGraph__SWIG_13(rowmap, colmap, rowpointers, columnindices) & +function swigf_new_TpetraCrsGraph__SWIG_13(rowmap, colmap, rowpointers, columnindices) & result(self) use, intrinsic :: ISO_C_BINDING type(TpetraCrsGraph) :: self class(TpetraMap), intent(in) :: rowmap - class(TpetraMap), intent(in) :: colmap - integer(C_LONG), dimension(:), target :: rowpointers integer(C_LONG), pointer :: farg3_view integer(C_INT), dimension(:), target :: columnindices integer(C_INT), pointer :: farg4_view - type(SwigClassWrapper) :: fresult type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 @@ -7624,7 +7435,6 @@ function new_TpetraCrsGraph__SWIG_13(rowmap, colmap, rowpointers, columnindices) subroutine delete_TpetraCrsGraph(self) use, intrinsic :: ISO_C_BINDING class(TpetraCrsGraph), intent(inout) :: self - type(SwigClassWrapper) :: farg1 farg1 = self%swigdata @@ -7637,10 +7447,8 @@ subroutine delete_TpetraCrsGraph(self) subroutine swigf_TpetraCrsGraph_swap(self, graph) use, intrinsic :: ISO_C_BINDING -class(TpetraCrsGraph), intent(inout) :: self - -class(TpetraCrsGraph), intent(inout) :: graph - +class(TpetraCrsGraph), intent(in) :: self +class(TpetraCrsGraph), intent(in) :: graph type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 @@ -7654,9 +7462,7 @@ function swigf_TpetraCrsGraph_isIdenticalTo(self, graph) & use, intrinsic :: ISO_C_BINDING logical :: swig_result class(TpetraCrsGraph), intent(in) :: self - class(TpetraCrsGraph), intent(in) :: graph - integer(C_INT) :: fresult type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 @@ -7669,10 +7475,8 @@ function swigf_TpetraCrsGraph_isIdenticalTo(self, graph) & subroutine swigf_TpetraCrsGraph_setParameterList(self, params) use, intrinsic :: ISO_C_BINDING -class(TpetraCrsGraph), intent(inout) :: self - +class(TpetraCrsGraph), intent(in) :: self class(ParameterList), intent(in) :: params - type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 @@ -7686,7 +7490,6 @@ function swigf_TpetraCrsGraph_getValidParameters(self) & use, intrinsic :: ISO_C_BINDING type(ParameterList) :: swig_result class(TpetraCrsGraph), intent(in) :: self - type(SwigClassWrapper) :: fresult type(SwigClassWrapper) :: farg1 @@ -7697,12 +7500,10 @@ function swigf_TpetraCrsGraph_getValidParameters(self) & subroutine swigf_TpetraCrsGraph_insertGlobalIndices__SWIG_0(self, globalrow, indices) use, intrinsic :: ISO_C_BINDING -class(TpetraCrsGraph), intent(inout) :: self - +class(TpetraCrsGraph), intent(in) :: self integer(C_LONG_LONG), intent(in) :: globalrow integer(C_LONG_LONG), dimension(:), target :: indices integer(C_LONG_LONG), pointer :: farg3_view - type(SwigClassWrapper) :: farg1 integer(C_LONG_LONG) :: farg2 type(SwigArrayWrapper) :: farg3 @@ -7722,12 +7523,10 @@ subroutine swigf_TpetraCrsGraph_insertGlobalIndices__SWIG_0(self, globalrow, ind subroutine swigf_TpetraCrsGraph_insertGlobalIndices__SWIG_1(self, globalrow, nument, inds) use, intrinsic :: ISO_C_BINDING -class(TpetraCrsGraph), intent(inout) :: self - +class(TpetraCrsGraph), intent(in) :: self integer(C_LONG_LONG), intent(in) :: globalrow integer, intent(in) :: nument integer(C_LONG_LONG), dimension(*), target, intent(in) :: inds - type(SwigClassWrapper) :: farg1 integer(C_LONG_LONG) :: farg2 integer(C_INT) :: farg3 @@ -7742,12 +7541,10 @@ subroutine swigf_TpetraCrsGraph_insertGlobalIndices__SWIG_1(self, globalrow, num subroutine swigf_TpetraCrsGraph_insertLocalIndices(self, localrow, indices) use, intrinsic :: ISO_C_BINDING -class(TpetraCrsGraph), intent(inout) :: self - +class(TpetraCrsGraph), intent(in) :: self integer, intent(in) :: localrow integer(C_INT), dimension(:), target :: indices integer(C_INT), pointer :: farg3_view - type(SwigClassWrapper) :: farg1 integer(C_INT) :: farg2 type(SwigArrayWrapper) :: farg3 @@ -7767,10 +7564,8 @@ subroutine swigf_TpetraCrsGraph_insertLocalIndices(self, localrow, indices) subroutine swigf_TpetraCrsGraph_removeLocalIndices(self, localrow) use, intrinsic :: ISO_C_BINDING -class(TpetraCrsGraph), intent(inout) :: self - +class(TpetraCrsGraph), intent(in) :: self integer, intent(in) :: localrow - type(SwigClassWrapper) :: farg1 integer(C_INT) :: farg2 @@ -7781,8 +7576,7 @@ subroutine swigf_TpetraCrsGraph_removeLocalIndices(self, localrow) subroutine swigf_TpetraCrsGraph_globalAssemble(self) use, intrinsic :: ISO_C_BINDING -class(TpetraCrsGraph), intent(inout) :: self - +class(TpetraCrsGraph), intent(in) :: self type(SwigClassWrapper) :: farg1 farg1 = self%swigdata @@ -7791,10 +7585,8 @@ subroutine swigf_TpetraCrsGraph_globalAssemble(self) subroutine swigf_TpetraCrsGraph_resumeFill__SWIG_0(self, params) use, intrinsic :: ISO_C_BINDING -class(TpetraCrsGraph), intent(inout) :: self - +class(TpetraCrsGraph), intent(in) :: self class(ParameterList), intent(in) :: params - type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 @@ -7805,8 +7597,7 @@ subroutine swigf_TpetraCrsGraph_resumeFill__SWIG_0(self, params) subroutine swigf_TpetraCrsGraph_resumeFill__SWIG_1(self) use, intrinsic :: ISO_C_BINDING -class(TpetraCrsGraph), intent(inout) :: self - +class(TpetraCrsGraph), intent(in) :: self type(SwigClassWrapper) :: farg1 farg1 = self%swigdata @@ -7815,14 +7606,10 @@ subroutine swigf_TpetraCrsGraph_resumeFill__SWIG_1(self) subroutine swigf_TpetraCrsGraph_fillComplete__SWIG_0(self, domainmap, rangemap, params) use, intrinsic :: ISO_C_BINDING -class(TpetraCrsGraph), intent(inout) :: self - +class(TpetraCrsGraph), intent(in) :: self class(TpetraMap), intent(in) :: domainmap - class(TpetraMap), intent(in) :: rangemap - class(ParameterList), intent(in) :: params - type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 type(SwigClassWrapper) :: farg3 @@ -7837,12 +7624,9 @@ subroutine swigf_TpetraCrsGraph_fillComplete__SWIG_0(self, domainmap, rangemap, subroutine swigf_TpetraCrsGraph_fillComplete__SWIG_1(self, domainmap, rangemap) use, intrinsic :: ISO_C_BINDING -class(TpetraCrsGraph), intent(inout) :: self - +class(TpetraCrsGraph), intent(in) :: self class(TpetraMap), intent(in) :: domainmap - class(TpetraMap), intent(in) :: rangemap - type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 type(SwigClassWrapper) :: farg3 @@ -7855,10 +7639,8 @@ subroutine swigf_TpetraCrsGraph_fillComplete__SWIG_1(self, domainmap, rangemap) subroutine swigf_TpetraCrsGraph_fillComplete__SWIG_2(self, params) use, intrinsic :: ISO_C_BINDING -class(TpetraCrsGraph), intent(inout) :: self - +class(TpetraCrsGraph), intent(in) :: self class(ParameterList), intent(in) :: params - type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 @@ -7869,8 +7651,7 @@ subroutine swigf_TpetraCrsGraph_fillComplete__SWIG_2(self, params) subroutine swigf_TpetraCrsGraph_fillComplete__SWIG_3(self) use, intrinsic :: ISO_C_BINDING -class(TpetraCrsGraph), intent(inout) :: self - +class(TpetraCrsGraph), intent(in) :: self type(SwigClassWrapper) :: farg1 farg1 = self%swigdata @@ -7879,18 +7660,12 @@ subroutine swigf_TpetraCrsGraph_fillComplete__SWIG_3(self) subroutine swigf_TpetraCrsGraph_expertStaticFillComplete__SWIG_0(self, domainmap, rangemap, importer, exporter, params) use, intrinsic :: ISO_C_BINDING -class(TpetraCrsGraph), intent(inout) :: self - +class(TpetraCrsGraph), intent(in) :: self class(TpetraMap), intent(in) :: domainmap - class(TpetraMap), intent(in) :: rangemap - class(TpetraImport), intent(in) :: importer - class(TpetraExport), intent(in) :: exporter - class(ParameterList), intent(in) :: params - type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 type(SwigClassWrapper) :: farg3 @@ -7909,16 +7684,11 @@ subroutine swigf_TpetraCrsGraph_expertStaticFillComplete__SWIG_0(self, domainmap subroutine swigf_TpetraCrsGraph_expertStaticFillComplete__SWIG_1(self, domainmap, rangemap, importer, exporter) use, intrinsic :: ISO_C_BINDING -class(TpetraCrsGraph), intent(inout) :: self - +class(TpetraCrsGraph), intent(in) :: self class(TpetraMap), intent(in) :: domainmap - class(TpetraMap), intent(in) :: rangemap - class(TpetraImport), intent(in) :: importer - class(TpetraExport), intent(in) :: exporter - type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 type(SwigClassWrapper) :: farg3 @@ -7935,14 +7705,10 @@ subroutine swigf_TpetraCrsGraph_expertStaticFillComplete__SWIG_1(self, domainmap subroutine swigf_TpetraCrsGraph_expertStaticFillComplete__SWIG_2(self, domainmap, rangemap, importer) use, intrinsic :: ISO_C_BINDING -class(TpetraCrsGraph), intent(inout) :: self - +class(TpetraCrsGraph), intent(in) :: self class(TpetraMap), intent(in) :: domainmap - class(TpetraMap), intent(in) :: rangemap - class(TpetraImport), intent(in) :: importer - type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 type(SwigClassWrapper) :: farg3 @@ -7957,12 +7723,9 @@ subroutine swigf_TpetraCrsGraph_expertStaticFillComplete__SWIG_2(self, domainmap subroutine swigf_TpetraCrsGraph_expertStaticFillComplete__SWIG_3(self, domainmap, rangemap) use, intrinsic :: ISO_C_BINDING -class(TpetraCrsGraph), intent(inout) :: self - +class(TpetraCrsGraph), intent(in) :: self class(TpetraMap), intent(in) :: domainmap - class(TpetraMap), intent(in) :: rangemap - type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 type(SwigClassWrapper) :: farg3 @@ -7978,7 +7741,6 @@ function swigf_TpetraCrsGraph_getComm(self) & use, intrinsic :: ISO_C_BINDING type(TeuchosComm) :: swig_result class(TpetraCrsGraph), intent(in) :: self - type(SwigClassWrapper) :: fresult type(SwigClassWrapper) :: farg1 @@ -7992,7 +7754,6 @@ function swigf_TpetraCrsGraph_getRowMap(self) & use, intrinsic :: ISO_C_BINDING type(TpetraMap) :: swig_result class(TpetraCrsGraph), intent(in) :: self - type(SwigClassWrapper) :: fresult type(SwigClassWrapper) :: farg1 @@ -8006,7 +7767,6 @@ function swigf_TpetraCrsGraph_getColMap(self) & use, intrinsic :: ISO_C_BINDING type(TpetraMap) :: swig_result class(TpetraCrsGraph), intent(in) :: self - type(SwigClassWrapper) :: fresult type(SwigClassWrapper) :: farg1 @@ -8020,7 +7780,6 @@ function swigf_TpetraCrsGraph_getDomainMap(self) & use, intrinsic :: ISO_C_BINDING type(TpetraMap) :: swig_result class(TpetraCrsGraph), intent(in) :: self - type(SwigClassWrapper) :: fresult type(SwigClassWrapper) :: farg1 @@ -8034,7 +7793,6 @@ function swigf_TpetraCrsGraph_getRangeMap(self) & use, intrinsic :: ISO_C_BINDING type(TpetraMap) :: swig_result class(TpetraCrsGraph), intent(in) :: self - type(SwigClassWrapper) :: fresult type(SwigClassWrapper) :: farg1 @@ -8048,7 +7806,6 @@ function swigf_TpetraCrsGraph_getImporter(self) & use, intrinsic :: ISO_C_BINDING type(TpetraImport) :: swig_result class(TpetraCrsGraph), intent(in) :: self - type(SwigClassWrapper) :: fresult type(SwigClassWrapper) :: farg1 @@ -8062,7 +7819,6 @@ function swigf_TpetraCrsGraph_getExporter(self) & use, intrinsic :: ISO_C_BINDING type(TpetraExport) :: swig_result class(TpetraCrsGraph), intent(in) :: self - type(SwigClassWrapper) :: fresult type(SwigClassWrapper) :: farg1 @@ -8076,7 +7832,6 @@ function swigf_TpetraCrsGraph_getGlobalNumRows(self) & use, intrinsic :: ISO_C_BINDING integer(C_LONG) :: swig_result class(TpetraCrsGraph), intent(in) :: self - integer(C_LONG) :: fresult type(SwigClassWrapper) :: farg1 @@ -8090,7 +7845,6 @@ function swigf_TpetraCrsGraph_getGlobalNumCols(self) & use, intrinsic :: ISO_C_BINDING integer(C_LONG) :: swig_result class(TpetraCrsGraph), intent(in) :: self - integer(C_LONG) :: fresult type(SwigClassWrapper) :: farg1 @@ -8104,7 +7858,6 @@ function swigf_TpetraCrsGraph_getNodeNumRows(self) & use, intrinsic :: ISO_C_BINDING integer(C_SIZE_T) :: swig_result class(TpetraCrsGraph), intent(in) :: self - integer(C_SIZE_T) :: fresult type(SwigClassWrapper) :: farg1 @@ -8118,7 +7871,6 @@ function swigf_TpetraCrsGraph_getNodeNumCols(self) & use, intrinsic :: ISO_C_BINDING integer(C_SIZE_T) :: swig_result class(TpetraCrsGraph), intent(in) :: self - integer(C_SIZE_T) :: fresult type(SwigClassWrapper) :: farg1 @@ -8132,7 +7884,6 @@ function swigf_TpetraCrsGraph_getGlobalNumEntries(self) & use, intrinsic :: ISO_C_BINDING integer(C_LONG) :: swig_result class(TpetraCrsGraph), intent(in) :: self - integer(C_LONG) :: fresult type(SwigClassWrapper) :: farg1 @@ -8146,7 +7897,6 @@ function swigf_TpetraCrsGraph_getNodeNumEntries(self) & use, intrinsic :: ISO_C_BINDING integer(C_SIZE_T) :: swig_result class(TpetraCrsGraph), intent(in) :: self - integer(C_SIZE_T) :: fresult type(SwigClassWrapper) :: farg1 @@ -8160,9 +7910,7 @@ function swigf_TpetraCrsGraph_getNumEntriesInGlobalRow(self, globalrow) & use, intrinsic :: ISO_C_BINDING integer(C_SIZE_T) :: swig_result class(TpetraCrsGraph), intent(in) :: self - integer(C_LONG_LONG), intent(in) :: globalrow - integer(C_SIZE_T) :: fresult type(SwigClassWrapper) :: farg1 integer(C_LONG_LONG) :: farg2 @@ -8178,9 +7926,7 @@ function swigf_TpetraCrsGraph_getNumEntriesInLocalRow(self, localrow) & use, intrinsic :: ISO_C_BINDING integer :: swig_result class(TpetraCrsGraph), intent(in) :: self - integer, intent(in) :: localrow - integer(C_INT) :: fresult type(SwigClassWrapper) :: farg1 integer(C_INT) :: farg2 @@ -8196,7 +7942,6 @@ function swigf_TpetraCrsGraph_getNodeAllocationSize(self) & use, intrinsic :: ISO_C_BINDING integer(C_SIZE_T) :: swig_result class(TpetraCrsGraph), intent(in) :: self - integer(C_SIZE_T) :: fresult type(SwigClassWrapper) :: farg1 @@ -8210,9 +7955,7 @@ function swigf_TpetraCrsGraph_getNumAllocatedEntriesInGlobalRow(self, globalrow) use, intrinsic :: ISO_C_BINDING integer(C_SIZE_T) :: swig_result class(TpetraCrsGraph), intent(in) :: self - integer(C_LONG_LONG), intent(in) :: globalrow - integer(C_SIZE_T) :: fresult type(SwigClassWrapper) :: farg1 integer(C_LONG_LONG) :: farg2 @@ -8228,9 +7971,7 @@ function swigf_TpetraCrsGraph_getNumAllocatedEntriesInLocalRow(self, localrow) & use, intrinsic :: ISO_C_BINDING integer :: swig_result class(TpetraCrsGraph), intent(in) :: self - integer, intent(in) :: localrow - integer(C_INT) :: fresult type(SwigClassWrapper) :: farg1 integer(C_INT) :: farg2 @@ -8246,7 +7987,6 @@ function swigf_TpetraCrsGraph_getGlobalMaxNumRowEntries(self) & use, intrinsic :: ISO_C_BINDING integer(C_SIZE_T) :: swig_result class(TpetraCrsGraph), intent(in) :: self - integer(C_SIZE_T) :: fresult type(SwigClassWrapper) :: farg1 @@ -8260,7 +8000,6 @@ function swigf_TpetraCrsGraph_getNodeMaxNumRowEntries(self) & use, intrinsic :: ISO_C_BINDING integer(C_SIZE_T) :: swig_result class(TpetraCrsGraph), intent(in) :: self - integer(C_SIZE_T) :: fresult type(SwigClassWrapper) :: farg1 @@ -8274,7 +8013,6 @@ function swigf_TpetraCrsGraph_hasColMap(self) & use, intrinsic :: ISO_C_BINDING logical :: swig_result class(TpetraCrsGraph), intent(in) :: self - integer(C_INT) :: fresult type(SwigClassWrapper) :: farg1 @@ -8288,7 +8026,6 @@ function swigf_TpetraCrsGraph_isLocallyIndexed(self) & use, intrinsic :: ISO_C_BINDING logical :: swig_result class(TpetraCrsGraph), intent(in) :: self - integer(C_INT) :: fresult type(SwigClassWrapper) :: farg1 @@ -8302,7 +8039,6 @@ function swigf_TpetraCrsGraph_isGloballyIndexed(self) & use, intrinsic :: ISO_C_BINDING logical :: swig_result class(TpetraCrsGraph), intent(in) :: self - integer(C_INT) :: fresult type(SwigClassWrapper) :: farg1 @@ -8316,7 +8052,6 @@ function swigf_TpetraCrsGraph_isFillComplete(self) & use, intrinsic :: ISO_C_BINDING logical :: swig_result class(TpetraCrsGraph), intent(in) :: self - integer(C_INT) :: fresult type(SwigClassWrapper) :: farg1 @@ -8330,7 +8065,6 @@ function swigf_TpetraCrsGraph_isFillActive(self) & use, intrinsic :: ISO_C_BINDING logical :: swig_result class(TpetraCrsGraph), intent(in) :: self - integer(C_INT) :: fresult type(SwigClassWrapper) :: farg1 @@ -8344,7 +8078,6 @@ function swigf_TpetraCrsGraph_isSorted(self) & use, intrinsic :: ISO_C_BINDING logical :: swig_result class(TpetraCrsGraph), intent(in) :: self - integer(C_INT) :: fresult type(SwigClassWrapper) :: farg1 @@ -8358,7 +8091,6 @@ function swigf_TpetraCrsGraph_isStorageOptimized(self) & use, intrinsic :: ISO_C_BINDING logical :: swig_result class(TpetraCrsGraph), intent(in) :: self - integer(C_INT) :: fresult type(SwigClassWrapper) :: farg1 @@ -8372,7 +8104,6 @@ function swigf_TpetraCrsGraph_getProfileType(self) & use, intrinsic :: ISO_C_BINDING integer(TpetraProfileType) :: swig_result class(TpetraCrsGraph), intent(in) :: self - integer(C_INT) :: fresult type(SwigClassWrapper) :: farg1 @@ -8384,12 +8115,10 @@ function swigf_TpetraCrsGraph_getProfileType(self) & subroutine swigf_TpetraCrsGraph_getGlobalRowCopy(self, globalrow, indices, numindices) use, intrinsic :: ISO_C_BINDING class(TpetraCrsGraph), intent(in) :: self - integer(C_LONG_LONG), intent(in) :: globalrow integer(C_LONG_LONG), dimension(:), target :: indices integer(C_LONG_LONG), pointer :: farg3_view integer(C_SIZE_T), target, intent(inout) :: numindices - type(SwigClassWrapper) :: farg1 integer(C_LONG_LONG) :: farg2 type(SwigArrayWrapper) :: farg3 @@ -8412,12 +8141,10 @@ subroutine swigf_TpetraCrsGraph_getGlobalRowCopy(self, globalrow, indices, numin subroutine swigf_TpetraCrsGraph_getLocalRowCopy(self, localrow, indices, numindices) use, intrinsic :: ISO_C_BINDING class(TpetraCrsGraph), intent(in) :: self - integer, intent(in) :: localrow integer(C_INT), dimension(:), target :: indices integer(C_INT), pointer :: farg3_view integer(C_SIZE_T), target, intent(inout) :: numindices - type(SwigClassWrapper) :: farg1 integer(C_INT) :: farg2 type(SwigArrayWrapper) :: farg3 @@ -8442,7 +8169,6 @@ function swigf_TpetraCrsGraph_supportsRowViews(self) & use, intrinsic :: ISO_C_BINDING logical :: swig_result class(TpetraCrsGraph), intent(in) :: self - integer(C_INT) :: fresult type(SwigClassWrapper) :: farg1 @@ -8456,7 +8182,6 @@ function swigf_TpetraCrsGraph_description(self) & use, intrinsic :: ISO_C_BINDING character(kind=C_CHAR, len=:), allocatable :: swig_result class(TpetraCrsGraph), intent(in) :: self - type(SwigArrayWrapper) :: fresult type(SwigClassWrapper) :: farg1 @@ -8468,10 +8193,8 @@ function swigf_TpetraCrsGraph_description(self) & subroutine swigf_TpetraCrsGraph_replaceColMap(self, newcolmap) use, intrinsic :: ISO_C_BINDING -class(TpetraCrsGraph), intent(inout) :: self - +class(TpetraCrsGraph), intent(in) :: self class(TpetraMap), intent(in) :: newcolmap - type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 @@ -8482,14 +8205,10 @@ subroutine swigf_TpetraCrsGraph_replaceColMap(self, newcolmap) subroutine swigf_TpetraCrsGraph_reindexColumns__SWIG_0(self, newcolmap, newimport, sortindicesineachrow) use, intrinsic :: ISO_C_BINDING -class(TpetraCrsGraph), intent(inout) :: self - +class(TpetraCrsGraph), intent(in) :: self class(TpetraMap), intent(in) :: newcolmap - class(TpetraImport), intent(in) :: newimport - logical, intent(in) :: sortindicesineachrow - type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 type(SwigClassWrapper) :: farg3 @@ -8504,12 +8223,9 @@ subroutine swigf_TpetraCrsGraph_reindexColumns__SWIG_0(self, newcolmap, newimpor subroutine swigf_TpetraCrsGraph_reindexColumns__SWIG_1(self, newcolmap, newimport) use, intrinsic :: ISO_C_BINDING -class(TpetraCrsGraph), intent(inout) :: self - +class(TpetraCrsGraph), intent(in) :: self class(TpetraMap), intent(in) :: newcolmap - class(TpetraImport), intent(in) :: newimport - type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 type(SwigClassWrapper) :: farg3 @@ -8522,10 +8238,8 @@ subroutine swigf_TpetraCrsGraph_reindexColumns__SWIG_1(self, newcolmap, newimpor subroutine swigf_TpetraCrsGraph_reindexColumns__SWIG_2(self, newcolmap) use, intrinsic :: ISO_C_BINDING -class(TpetraCrsGraph), intent(inout) :: self - +class(TpetraCrsGraph), intent(in) :: self class(TpetraMap), intent(in) :: newcolmap - type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 @@ -8536,12 +8250,9 @@ subroutine swigf_TpetraCrsGraph_reindexColumns__SWIG_2(self, newcolmap) subroutine swigf_TpetraCrsGraph_replaceDomainMapAndImporter(self, newdomainmap, newimporter) use, intrinsic :: ISO_C_BINDING -class(TpetraCrsGraph), intent(inout) :: self - +class(TpetraCrsGraph), intent(in) :: self class(TpetraMap), intent(in) :: newdomainmap - class(TpetraImport), intent(in) :: newimporter - type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 type(SwigClassWrapper) :: farg3 @@ -8554,10 +8265,8 @@ subroutine swigf_TpetraCrsGraph_replaceDomainMapAndImporter(self, newdomainmap, subroutine swigf_TpetraCrsGraph_removeEmptyProcessesInPlace(self, newmap) use, intrinsic :: ISO_C_BINDING -class(TpetraCrsGraph), intent(inout) :: self - +class(TpetraCrsGraph), intent(in) :: self class(TpetraMap), intent(in) :: newmap - type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 @@ -8569,17 +8278,11 @@ subroutine swigf_TpetraCrsGraph_removeEmptyProcessesInPlace(self, newmap) subroutine swigf_TpetraCrsGraph_importAndFillComplete__SWIG_0(self, destgraph, importer, domainmap, rangemap, params) use, intrinsic :: ISO_C_BINDING class(TpetraCrsGraph), intent(in) :: self - -class(TpetraCrsGraph), intent(inout) :: destgraph - +class(TpetraCrsGraph), intent(in) :: destgraph class(TpetraImport), intent(in) :: importer - class(TpetraMap), intent(in) :: domainmap - class(TpetraMap), intent(in) :: rangemap - class(ParameterList), intent(in) :: params - type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 type(SwigClassWrapper) :: farg3 @@ -8599,15 +8302,10 @@ subroutine swigf_TpetraCrsGraph_importAndFillComplete__SWIG_0(self, destgraph, i subroutine swigf_TpetraCrsGraph_importAndFillComplete__SWIG_1(self, destgraph, importer, domainmap, rangemap) use, intrinsic :: ISO_C_BINDING class(TpetraCrsGraph), intent(in) :: self - -class(TpetraCrsGraph), intent(inout) :: destgraph - +class(TpetraCrsGraph), intent(in) :: destgraph class(TpetraImport), intent(in) :: importer - class(TpetraMap), intent(in) :: domainmap - class(TpetraMap), intent(in) :: rangemap - type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 type(SwigClassWrapper) :: farg3 @@ -8626,19 +8324,12 @@ subroutine swigf_TpetraCrsGraph_importAndFillComplete__SWIG_2(self, destgraph, r rangemap, params) use, intrinsic :: ISO_C_BINDING class(TpetraCrsGraph), intent(in) :: self - -class(TpetraCrsGraph), intent(inout) :: destgraph - +class(TpetraCrsGraph), intent(in) :: destgraph class(TpetraImport), intent(in) :: rowimporter - class(TpetraImport), intent(in) :: domainimporter - class(TpetraMap), intent(in) :: domainmap - class(TpetraMap), intent(in) :: rangemap - class(ParameterList), intent(in) :: params - type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 type(SwigClassWrapper) :: farg3 @@ -8660,17 +8351,11 @@ subroutine swigf_TpetraCrsGraph_importAndFillComplete__SWIG_2(self, destgraph, r subroutine swigf_TpetraCrsGraph_exportAndFillComplete__SWIG_0(self, destgraph, exporter, domainmap, rangemap, params) use, intrinsic :: ISO_C_BINDING class(TpetraCrsGraph), intent(in) :: self - -class(TpetraCrsGraph), intent(inout) :: destgraph - +class(TpetraCrsGraph), intent(in) :: destgraph class(TpetraExport), intent(in) :: exporter - class(TpetraMap), intent(in) :: domainmap - class(TpetraMap), intent(in) :: rangemap - class(ParameterList), intent(in) :: params - type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 type(SwigClassWrapper) :: farg3 @@ -8690,15 +8375,10 @@ subroutine swigf_TpetraCrsGraph_exportAndFillComplete__SWIG_0(self, destgraph, e subroutine swigf_TpetraCrsGraph_exportAndFillComplete__SWIG_1(self, destgraph, exporter, domainmap, rangemap) use, intrinsic :: ISO_C_BINDING class(TpetraCrsGraph), intent(in) :: self - -class(TpetraCrsGraph), intent(inout) :: destgraph - +class(TpetraCrsGraph), intent(in) :: destgraph class(TpetraExport), intent(in) :: exporter - class(TpetraMap), intent(in) :: domainmap - class(TpetraMap), intent(in) :: rangemap - type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 type(SwigClassWrapper) :: farg3 @@ -8716,13 +8396,9 @@ subroutine swigf_TpetraCrsGraph_exportAndFillComplete__SWIG_1(self, destgraph, e subroutine swigf_TpetraCrsGraph_exportAndFillComplete__SWIG_2(self, destgraph, exporter, domainmap) use, intrinsic :: ISO_C_BINDING class(TpetraCrsGraph), intent(in) :: self - -class(TpetraCrsGraph), intent(inout) :: destgraph - +class(TpetraCrsGraph), intent(in) :: destgraph class(TpetraExport), intent(in) :: exporter - class(TpetraMap), intent(in) :: domainmap - type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 type(SwigClassWrapper) :: farg3 @@ -8738,11 +8414,8 @@ subroutine swigf_TpetraCrsGraph_exportAndFillComplete__SWIG_2(self, destgraph, e subroutine swigf_TpetraCrsGraph_exportAndFillComplete__SWIG_3(self, destgraph, exporter) use, intrinsic :: ISO_C_BINDING class(TpetraCrsGraph), intent(in) :: self - -class(TpetraCrsGraph), intent(inout) :: destgraph - +class(TpetraCrsGraph), intent(in) :: destgraph class(TpetraExport), intent(in) :: exporter - type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 type(SwigClassWrapper) :: farg3 @@ -8757,19 +8430,12 @@ subroutine swigf_TpetraCrsGraph_exportAndFillComplete__SWIG_4(self, destgraph, r rangemap, params) use, intrinsic :: ISO_C_BINDING class(TpetraCrsGraph), intent(in) :: self - -class(TpetraCrsGraph), intent(inout) :: destgraph - +class(TpetraCrsGraph), intent(in) :: destgraph class(TpetraExport), intent(in) :: rowexporter - class(TpetraExport), intent(in) :: domainexporter - class(TpetraMap), intent(in) :: domainmap - class(TpetraMap), intent(in) :: rangemap - class(ParameterList), intent(in) :: params - type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 type(SwigClassWrapper) :: farg3 @@ -8793,7 +8459,6 @@ function swigf_TpetraCrsGraph_haveGlobalConstants(self) & use, intrinsic :: ISO_C_BINDING logical :: swig_result class(TpetraCrsGraph), intent(in) :: self - integer(C_INT) :: fresult type(SwigClassWrapper) :: farg1 @@ -8804,10 +8469,8 @@ function swigf_TpetraCrsGraph_haveGlobalConstants(self) & subroutine swigf_TpetraCrsGraph_computeGlobalConstants(self, computelocaltriangularconstants) use, intrinsic :: ISO_C_BINDING -class(TpetraCrsGraph), intent(inout) :: self - +class(TpetraCrsGraph), intent(in) :: self logical, intent(in) :: computelocaltriangularconstants - type(SwigClassWrapper) :: farg1 integer(C_INT) :: farg2 @@ -8819,10 +8482,8 @@ subroutine swigf_TpetraCrsGraph_computeGlobalConstants(self, computelocaltriangu subroutine swigf_TpetraCrsGraph_getNodeRowPtrs(self, rowpointers) use, intrinsic :: ISO_C_BINDING class(TpetraCrsGraph), intent(in) :: self - integer(C_LONG), dimension(:), target :: rowpointers integer(C_LONG), pointer :: farg2_view - type(SwigClassWrapper) :: farg1 type(SwigArrayWrapper) :: farg2 @@ -8841,10 +8502,8 @@ subroutine swigf_TpetraCrsGraph_getNodeRowPtrs(self, rowpointers) subroutine swigf_TpetraCrsGraph_getNodePackedIndices(self, columnindices) use, intrinsic :: ISO_C_BINDING class(TpetraCrsGraph), intent(in) :: self - integer(C_LONG), dimension(:), target :: columnindices integer(C_LONG), pointer :: farg2_view - type(SwigClassWrapper) :: farg1 type(SwigArrayWrapper) :: farg2 @@ -8862,14 +8521,10 @@ subroutine swigf_TpetraCrsGraph_getNodePackedIndices(self, columnindices) subroutine swigf_TpetraCrsGraph_doImport__SWIG_0(self, source, importer, cm) use, intrinsic :: ISO_C_BINDING -class(TpetraCrsGraph), intent(inout) :: self - +class(TpetraCrsGraph), intent(in) :: self class(TpetraCrsGraph), intent(in) :: source - class(TpetraImport), intent(in) :: importer - integer(TpetraCombineMode), intent(in) :: cm - type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 type(SwigClassWrapper) :: farg3 @@ -8884,14 +8539,10 @@ subroutine swigf_TpetraCrsGraph_doImport__SWIG_0(self, source, importer, cm) subroutine swigf_TpetraCrsGraph_doImport__SWIG_1(self, source, exporter, cm) use, intrinsic :: ISO_C_BINDING -class(TpetraCrsGraph), intent(inout) :: self - +class(TpetraCrsGraph), intent(in) :: self class(TpetraCrsGraph), intent(in) :: source - class(TpetraExport), intent(in) :: exporter - integer(TpetraCombineMode), intent(in) :: cm - type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 type(SwigClassWrapper) :: farg3 @@ -8906,14 +8557,10 @@ subroutine swigf_TpetraCrsGraph_doImport__SWIG_1(self, source, exporter, cm) subroutine swigf_TpetraCrsGraph_doExport__SWIG_0(self, source, exporter, cm) use, intrinsic :: ISO_C_BINDING -class(TpetraCrsGraph), intent(inout) :: self - +class(TpetraCrsGraph), intent(in) :: self class(TpetraCrsGraph), intent(in) :: source - class(TpetraExport), intent(in) :: exporter - integer(TpetraCombineMode), intent(in) :: cm - type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 type(SwigClassWrapper) :: farg3 @@ -8928,14 +8575,10 @@ subroutine swigf_TpetraCrsGraph_doExport__SWIG_0(self, source, exporter, cm) subroutine swigf_TpetraCrsGraph_doExport__SWIG_1(self, source, importer, cm) use, intrinsic :: ISO_C_BINDING -class(TpetraCrsGraph), intent(inout) :: self - +class(TpetraCrsGraph), intent(in) :: self class(TpetraCrsGraph), intent(in) :: source - class(TpetraImport), intent(in) :: importer - integer(TpetraCombineMode), intent(in) :: cm - type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 type(SwigClassWrapper) :: farg3 @@ -8948,22 +8591,27 @@ subroutine swigf_TpetraCrsGraph_doExport__SWIG_1(self, source, importer, cm) call swigc_TpetraCrsGraph_doExport__SWIG_1(farg1, farg2, farg3, farg4) end subroutine - subroutine swigf_assignment_TpetraCrsGraph(self, other) - use, intrinsic :: ISO_C_BINDING - class(TpetraCrsGraph), intent(inout) :: self - type(TpetraCrsGraph), intent(in) :: other - call swigc_assignment_TpetraCrsGraph(self%swigdata, other%swigdata) - end subroutine -function new_TpetraCrsMatrix__SWIG_0(rowmap, maxnumentriesperrow, pftype, params) & +subroutine swigf_TpetraCrsGraph_op_assign__(self, other) +use, intrinsic :: ISO_C_BINDING +class(TpetraCrsGraph), intent(inout) :: self +type(SWIGTYPE_Tpetra__CrsGraphT_LO_GO_NO_t), intent(in) :: other +type(SwigClassWrapper) :: farg1 +type(SwigClassWrapper) :: farg2 + +farg1 = self%swigdata +farg2 = other%swigdata +call swigc_TpetraCrsGraph_op_assign__(farg1, farg2) +self%swigdata = farg1 +end subroutine + +function swigf_new_TpetraCrsMatrix__SWIG_0(rowmap, maxnumentriesperrow, pftype, params) & result(self) use, intrinsic :: ISO_C_BINDING type(TpetraCrsMatrix) :: self class(TpetraMap), intent(in) :: rowmap - integer(C_SIZE_T), intent(in) :: maxnumentriesperrow integer(TpetraProfileType), intent(in) :: pftype class(ParameterList), intent(in) :: params - type(SwigClassWrapper) :: fresult type(SwigClassWrapper) :: farg1 integer(C_SIZE_T) :: farg2 @@ -8978,15 +8626,13 @@ function new_TpetraCrsMatrix__SWIG_0(rowmap, maxnumentriesperrow, pftype, params self%swigdata = fresult end function -function new_TpetraCrsMatrix__SWIG_1(rowmap, maxnumentriesperrow, pftype) & +function swigf_new_TpetraCrsMatrix__SWIG_1(rowmap, maxnumentriesperrow, pftype) & result(self) use, intrinsic :: ISO_C_BINDING type(TpetraCrsMatrix) :: self class(TpetraMap), intent(in) :: rowmap - integer(C_SIZE_T), intent(in) :: maxnumentriesperrow integer(TpetraProfileType), intent(in) :: pftype - type(SwigClassWrapper) :: fresult type(SwigClassWrapper) :: farg1 integer(C_SIZE_T) :: farg2 @@ -8999,14 +8645,12 @@ function new_TpetraCrsMatrix__SWIG_1(rowmap, maxnumentriesperrow, pftype) & self%swigdata = fresult end function -function new_TpetraCrsMatrix__SWIG_2(rowmap, maxnumentriesperrow) & +function swigf_new_TpetraCrsMatrix__SWIG_2(rowmap, maxnumentriesperrow) & result(self) use, intrinsic :: ISO_C_BINDING type(TpetraCrsMatrix) :: self class(TpetraMap), intent(in) :: rowmap - integer(C_SIZE_T), intent(in) :: maxnumentriesperrow - type(SwigClassWrapper) :: fresult type(SwigClassWrapper) :: farg1 integer(C_SIZE_T) :: farg2 @@ -9017,17 +8661,15 @@ function new_TpetraCrsMatrix__SWIG_2(rowmap, maxnumentriesperrow) & self%swigdata = fresult end function -function new_TpetraCrsMatrix__SWIG_3(rowmap, numentriesperrowtoalloc, pftype, params) & +function swigf_new_TpetraCrsMatrix__SWIG_3(rowmap, numentriesperrowtoalloc, pftype, params) & result(self) use, intrinsic :: ISO_C_BINDING type(TpetraCrsMatrix) :: self class(TpetraMap), intent(in) :: rowmap - integer(C_LONG), dimension(:), target :: numentriesperrowtoalloc integer(C_LONG), pointer :: farg2_view integer(TpetraProfileType), intent(in) :: pftype class(ParameterList), intent(in) :: params - type(SwigClassWrapper) :: fresult type(SwigClassWrapper) :: farg1 type(SwigArrayWrapper) :: farg2 @@ -9049,16 +8691,14 @@ function new_TpetraCrsMatrix__SWIG_3(rowmap, numentriesperrowtoalloc, pftype, pa self%swigdata = fresult end function -function new_TpetraCrsMatrix__SWIG_4(rowmap, numentriesperrowtoalloc, pftype) & +function swigf_new_TpetraCrsMatrix__SWIG_4(rowmap, numentriesperrowtoalloc, pftype) & result(self) use, intrinsic :: ISO_C_BINDING type(TpetraCrsMatrix) :: self class(TpetraMap), intent(in) :: rowmap - integer(C_LONG), dimension(:), target :: numentriesperrowtoalloc integer(C_LONG), pointer :: farg2_view integer(TpetraProfileType), intent(in) :: pftype - type(SwigClassWrapper) :: fresult type(SwigClassWrapper) :: farg1 type(SwigArrayWrapper) :: farg2 @@ -9078,15 +8718,13 @@ function new_TpetraCrsMatrix__SWIG_4(rowmap, numentriesperrowtoalloc, pftype) & self%swigdata = fresult end function -function new_TpetraCrsMatrix__SWIG_5(rowmap, numentriesperrowtoalloc) & +function swigf_new_TpetraCrsMatrix__SWIG_5(rowmap, numentriesperrowtoalloc) & result(self) use, intrinsic :: ISO_C_BINDING type(TpetraCrsMatrix) :: self class(TpetraMap), intent(in) :: rowmap - integer(C_LONG), dimension(:), target :: numentriesperrowtoalloc integer(C_LONG), pointer :: farg2_view - type(SwigClassWrapper) :: fresult type(SwigClassWrapper) :: farg1 type(SwigArrayWrapper) :: farg2 @@ -9104,18 +8742,15 @@ function new_TpetraCrsMatrix__SWIG_5(rowmap, numentriesperrowtoalloc) & self%swigdata = fresult end function -function new_TpetraCrsMatrix__SWIG_6(rowmap, colmap, maxnumentriesperrow, pftype, params) & +function swigf_new_TpetraCrsMatrix__SWIG_6(rowmap, colmap, maxnumentriesperrow, pftype, params) & result(self) use, intrinsic :: ISO_C_BINDING type(TpetraCrsMatrix) :: self class(TpetraMap), intent(in) :: rowmap - class(TpetraMap), intent(in) :: colmap - integer(C_SIZE_T), intent(in) :: maxnumentriesperrow integer(TpetraProfileType), intent(in) :: pftype class(ParameterList), intent(in) :: params - type(SwigClassWrapper) :: fresult type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 @@ -9132,17 +8767,14 @@ function new_TpetraCrsMatrix__SWIG_6(rowmap, colmap, maxnumentriesperrow, pftype self%swigdata = fresult end function -function new_TpetraCrsMatrix__SWIG_7(rowmap, colmap, maxnumentriesperrow, pftype) & +function swigf_new_TpetraCrsMatrix__SWIG_7(rowmap, colmap, maxnumentriesperrow, pftype) & result(self) use, intrinsic :: ISO_C_BINDING type(TpetraCrsMatrix) :: self class(TpetraMap), intent(in) :: rowmap - class(TpetraMap), intent(in) :: colmap - integer(C_SIZE_T), intent(in) :: maxnumentriesperrow integer(TpetraProfileType), intent(in) :: pftype - type(SwigClassWrapper) :: fresult type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 @@ -9157,16 +8789,13 @@ function new_TpetraCrsMatrix__SWIG_7(rowmap, colmap, maxnumentriesperrow, pftype self%swigdata = fresult end function -function new_TpetraCrsMatrix__SWIG_8(rowmap, colmap, maxnumentriesperrow) & +function swigf_new_TpetraCrsMatrix__SWIG_8(rowmap, colmap, maxnumentriesperrow) & result(self) use, intrinsic :: ISO_C_BINDING type(TpetraCrsMatrix) :: self class(TpetraMap), intent(in) :: rowmap - class(TpetraMap), intent(in) :: colmap - integer(C_SIZE_T), intent(in) :: maxnumentriesperrow - type(SwigClassWrapper) :: fresult type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 @@ -9179,19 +8808,16 @@ function new_TpetraCrsMatrix__SWIG_8(rowmap, colmap, maxnumentriesperrow) & self%swigdata = fresult end function -function new_TpetraCrsMatrix__SWIG_9(rowmap, colmap, numentriesperrowtoalloc, pftype, params) & +function swigf_new_TpetraCrsMatrix__SWIG_9(rowmap, colmap, numentriesperrowtoalloc, pftype, params) & result(self) use, intrinsic :: ISO_C_BINDING type(TpetraCrsMatrix) :: self class(TpetraMap), intent(in) :: rowmap - class(TpetraMap), intent(in) :: colmap - integer(C_LONG), dimension(:), target :: numentriesperrowtoalloc integer(C_LONG), pointer :: farg3_view integer(TpetraProfileType), intent(in) :: pftype class(ParameterList), intent(in) :: params - type(SwigClassWrapper) :: fresult type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 @@ -9215,18 +8841,15 @@ function new_TpetraCrsMatrix__SWIG_9(rowmap, colmap, numentriesperrowtoalloc, pf self%swigdata = fresult end function -function new_TpetraCrsMatrix__SWIG_10(rowmap, colmap, numentriesperrowtoalloc, pftype) & +function swigf_new_TpetraCrsMatrix__SWIG_10(rowmap, colmap, numentriesperrowtoalloc, pftype) & result(self) use, intrinsic :: ISO_C_BINDING type(TpetraCrsMatrix) :: self class(TpetraMap), intent(in) :: rowmap - class(TpetraMap), intent(in) :: colmap - integer(C_LONG), dimension(:), target :: numentriesperrowtoalloc integer(C_LONG), pointer :: farg3_view integer(TpetraProfileType), intent(in) :: pftype - type(SwigClassWrapper) :: fresult type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 @@ -9248,17 +8871,14 @@ function new_TpetraCrsMatrix__SWIG_10(rowmap, colmap, numentriesperrowtoalloc, p self%swigdata = fresult end function -function new_TpetraCrsMatrix__SWIG_11(rowmap, colmap, numentriesperrowtoalloc) & +function swigf_new_TpetraCrsMatrix__SWIG_11(rowmap, colmap, numentriesperrowtoalloc) & result(self) use, intrinsic :: ISO_C_BINDING type(TpetraCrsMatrix) :: self class(TpetraMap), intent(in) :: rowmap - class(TpetraMap), intent(in) :: colmap - integer(C_LONG), dimension(:), target :: numentriesperrowtoalloc integer(C_LONG), pointer :: farg3_view - type(SwigClassWrapper) :: fresult type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 @@ -9278,14 +8898,12 @@ function new_TpetraCrsMatrix__SWIG_11(rowmap, colmap, numentriesperrowtoalloc) & self%swigdata = fresult end function -function new_TpetraCrsMatrix__SWIG_12(graph, params) & +function swigf_new_TpetraCrsMatrix__SWIG_12(graph, params) & result(self) use, intrinsic :: ISO_C_BINDING type(TpetraCrsMatrix) :: self class(TpetraCrsGraph), intent(in) :: graph - class(ParameterList), intent(in) :: params - type(SwigClassWrapper) :: fresult type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 @@ -9296,12 +8914,11 @@ function new_TpetraCrsMatrix__SWIG_12(graph, params) & self%swigdata = fresult end function -function new_TpetraCrsMatrix__SWIG_13(graph) & +function swigf_new_TpetraCrsMatrix__SWIG_13(graph) & result(self) use, intrinsic :: ISO_C_BINDING type(TpetraCrsMatrix) :: self class(TpetraCrsGraph), intent(in) :: graph - type(SwigClassWrapper) :: fresult type(SwigClassWrapper) :: farg1 @@ -9310,16 +8927,13 @@ function new_TpetraCrsMatrix__SWIG_13(graph) & self%swigdata = fresult end function -function new_TpetraCrsMatrix__SWIG_14(graph, values, params) & +function swigf_new_TpetraCrsMatrix__SWIG_14(graph, values, params) & result(self) use, intrinsic :: ISO_C_BINDING type(TpetraCrsMatrix) :: self class(TpetraCrsGraph), intent(in) :: graph - class(SWIGTYPE_KokkosSparse__CrsMatrixT_Tpetra__CrsMatrixT_doub1E12GN), intent(in) :: values - class(ParameterList), intent(in) :: params - type(SwigClassWrapper) :: fresult type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 @@ -9332,14 +8946,12 @@ function new_TpetraCrsMatrix__SWIG_14(graph, values, params) & self%swigdata = fresult end function -function new_TpetraCrsMatrix__SWIG_15(graph, values) & +function swigf_new_TpetraCrsMatrix__SWIG_15(graph, values) & result(self) use, intrinsic :: ISO_C_BINDING type(TpetraCrsMatrix) :: self class(TpetraCrsGraph), intent(in) :: graph - class(SWIGTYPE_KokkosSparse__CrsMatrixT_Tpetra__CrsMatrixT_doub1E12GN), intent(in) :: values - type(SwigClassWrapper) :: fresult type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 @@ -9350,14 +8962,12 @@ function new_TpetraCrsMatrix__SWIG_15(graph, values) & self%swigdata = fresult end function -function new_TpetraCrsMatrix__SWIG_16(rowmap, colmap, rowpointers, columnindices, values, params) & +function swigf_new_TpetraCrsMatrix__SWIG_16(rowmap, colmap, rowpointers, columnindices, values, params) & result(self) use, intrinsic :: ISO_C_BINDING type(TpetraCrsMatrix) :: self class(TpetraMap), intent(in) :: rowmap - class(TpetraMap), intent(in) :: colmap - integer(C_LONG), dimension(:), target :: rowpointers integer(C_LONG), pointer :: farg3_view integer(C_INT), dimension(:), target :: columnindices @@ -9365,7 +8975,6 @@ function new_TpetraCrsMatrix__SWIG_16(rowmap, colmap, rowpointers, columnindices real(C_DOUBLE), dimension(:), target :: values real(C_DOUBLE), pointer :: farg5_view class(ParameterList), intent(in) :: params - type(SwigClassWrapper) :: fresult type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 @@ -9405,21 +9014,18 @@ function new_TpetraCrsMatrix__SWIG_16(rowmap, colmap, rowpointers, columnindices self%swigdata = fresult end function -function new_TpetraCrsMatrix__SWIG_17(rowmap, colmap, rowpointers, columnindices, values) & +function swigf_new_TpetraCrsMatrix__SWIG_17(rowmap, colmap, rowpointers, columnindices, values) & result(self) use, intrinsic :: ISO_C_BINDING type(TpetraCrsMatrix) :: self class(TpetraMap), intent(in) :: rowmap - class(TpetraMap), intent(in) :: colmap - integer(C_LONG), dimension(:), target :: rowpointers integer(C_LONG), pointer :: farg3_view integer(C_INT), dimension(:), target :: columnindices integer(C_INT), pointer :: farg4_view real(C_DOUBLE), dimension(:), target :: values real(C_DOUBLE), pointer :: farg5_view - type(SwigClassWrapper) :: fresult type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 @@ -9460,7 +9066,6 @@ function new_TpetraCrsMatrix__SWIG_17(rowmap, colmap, rowpointers, columnindices subroutine delete_TpetraCrsMatrix(self) use, intrinsic :: ISO_C_BINDING class(TpetraCrsMatrix), intent(inout) :: self - type(SwigClassWrapper) :: farg1 farg1 = self%swigdata @@ -9473,14 +9078,12 @@ subroutine delete_TpetraCrsMatrix(self) subroutine swigf_TpetraCrsMatrix_insertGlobalValues(self, globalrow, cols, vals) use, intrinsic :: ISO_C_BINDING -class(TpetraCrsMatrix), intent(inout) :: self - +class(TpetraCrsMatrix), intent(in) :: self integer(C_LONG_LONG), intent(in) :: globalrow integer(C_LONG_LONG), dimension(:), target :: cols integer(C_LONG_LONG), pointer :: farg3_view real(C_DOUBLE), dimension(:), target :: vals real(C_DOUBLE), pointer :: farg4_view - type(SwigClassWrapper) :: farg1 integer(C_LONG_LONG) :: farg2 type(SwigArrayWrapper) :: farg3 @@ -9509,14 +9112,12 @@ subroutine swigf_TpetraCrsMatrix_insertGlobalValues(self, globalrow, cols, vals) subroutine swigf_TpetraCrsMatrix_insertLocalValues(self, localrow, cols, vals) use, intrinsic :: ISO_C_BINDING -class(TpetraCrsMatrix), intent(inout) :: self - +class(TpetraCrsMatrix), intent(in) :: self integer, intent(in) :: localrow integer(C_INT), dimension(:), target :: cols integer(C_INT), pointer :: farg3_view real(C_DOUBLE), dimension(:), target :: vals real(C_DOUBLE), pointer :: farg4_view - type(SwigClassWrapper) :: farg1 integer(C_INT) :: farg2 type(SwigArrayWrapper) :: farg3 @@ -9548,13 +9149,11 @@ function swigf_TpetraCrsMatrix_replaceGlobalValues(self, globalrow, cols, vals) use, intrinsic :: ISO_C_BINDING integer :: swig_result class(TpetraCrsMatrix), intent(in) :: self - integer(C_LONG_LONG), intent(in) :: globalrow integer(C_LONG_LONG), dimension(:), target :: cols integer(C_LONG_LONG), pointer :: farg3_view real(C_DOUBLE), dimension(:), target :: vals real(C_DOUBLE), pointer :: farg4_view - integer(C_INT) :: fresult type(SwigClassWrapper) :: farg1 integer(C_LONG_LONG) :: farg2 @@ -9588,13 +9187,11 @@ function swigf_TpetraCrsMatrix_replaceLocalValues__SWIG_1(self, localrow, cols, use, intrinsic :: ISO_C_BINDING integer :: swig_result class(TpetraCrsMatrix), intent(in) :: self - integer, intent(in) :: localrow integer(C_INT), dimension(:), target :: cols integer(C_INT), pointer :: farg3_view real(C_DOUBLE), dimension(:), target :: vals real(C_DOUBLE), pointer :: farg4_view - integer(C_INT) :: fresult type(SwigClassWrapper) :: farg1 integer(C_INT) :: farg2 @@ -9628,12 +9225,10 @@ function swigf_TpetraCrsMatrix_replaceLocalValues__SWIG_2(self, localrow, nument use, intrinsic :: ISO_C_BINDING integer :: swig_result class(TpetraCrsMatrix), intent(in) :: self - integer, intent(in) :: localrow integer, intent(in) :: nument real(C_DOUBLE), dimension(*), target, intent(in) :: inputvals integer, dimension(*), target, intent(in) :: inputcols - integer(C_INT) :: fresult type(SwigClassWrapper) :: farg1 integer(C_INT) :: farg2 @@ -9654,14 +9249,12 @@ function swigf_TpetraCrsMatrix_sumIntoGlobalValues__SWIG_0(self, globalrow, cols result(swig_result) use, intrinsic :: ISO_C_BINDING integer :: swig_result -class(TpetraCrsMatrix), intent(inout) :: self - +class(TpetraCrsMatrix), intent(in) :: self integer(C_LONG_LONG), intent(in) :: globalrow integer(C_LONG_LONG), dimension(:), target :: cols integer(C_LONG_LONG), pointer :: farg3_view real(C_DOUBLE), dimension(:), target :: vals real(C_DOUBLE), pointer :: farg4_view - integer(C_INT) :: fresult type(SwigClassWrapper) :: farg1 integer(C_LONG_LONG) :: farg2 @@ -9695,13 +9288,11 @@ function swigf_TpetraCrsMatrix_sumIntoLocalValues__SWIG_0(self, localrow, cols, use, intrinsic :: ISO_C_BINDING integer :: swig_result class(TpetraCrsMatrix), intent(in) :: self - integer, intent(in) :: localrow integer(C_INT), dimension(:), target :: cols integer(C_INT), pointer :: farg3_view real(C_DOUBLE), dimension(:), target :: vals real(C_DOUBLE), pointer :: farg4_view - integer(C_INT) :: fresult type(SwigClassWrapper) :: farg1 integer(C_INT) :: farg2 @@ -9732,10 +9323,8 @@ function swigf_TpetraCrsMatrix_sumIntoLocalValues__SWIG_0(self, localrow, cols, subroutine swigf_TpetraCrsMatrix_setAllToScalar(self, alpha) use, intrinsic :: ISO_C_BINDING -class(TpetraCrsMatrix), intent(inout) :: self - +class(TpetraCrsMatrix), intent(in) :: self real(C_DOUBLE), intent(in) :: alpha - type(SwigClassWrapper) :: farg1 real(C_DOUBLE) :: farg2 @@ -9746,10 +9335,8 @@ subroutine swigf_TpetraCrsMatrix_setAllToScalar(self, alpha) subroutine swigf_TpetraCrsMatrix_scale(self, alpha) use, intrinsic :: ISO_C_BINDING -class(TpetraCrsMatrix), intent(inout) :: self - +class(TpetraCrsMatrix), intent(in) :: self real(C_DOUBLE), intent(in) :: alpha - type(SwigClassWrapper) :: farg1 real(C_DOUBLE) :: farg2 @@ -9760,15 +9347,13 @@ subroutine swigf_TpetraCrsMatrix_scale(self, alpha) subroutine swigf_TpetraCrsMatrix_setAllValues(self, ptr, ind, val) use, intrinsic :: ISO_C_BINDING -class(TpetraCrsMatrix), intent(inout) :: self - +class(TpetraCrsMatrix), intent(in) :: self integer(C_LONG), dimension(:), target :: ptr integer(C_LONG), pointer :: farg2_view integer(C_INT), dimension(:), target :: ind integer(C_INT), pointer :: farg3_view real(C_DOUBLE), dimension(:), target :: val real(C_DOUBLE), pointer :: farg4_view - type(SwigClassWrapper) :: farg1 type(SwigArrayWrapper) :: farg2 type(SwigArrayWrapper) :: farg3 @@ -9804,8 +9389,7 @@ subroutine swigf_TpetraCrsMatrix_setAllValues(self, ptr, ind, val) subroutine swigf_TpetraCrsMatrix_globalAssemble(self) use, intrinsic :: ISO_C_BINDING -class(TpetraCrsMatrix), intent(inout) :: self - +class(TpetraCrsMatrix), intent(in) :: self type(SwigClassWrapper) :: farg1 farg1 = self%swigdata @@ -9814,10 +9398,8 @@ subroutine swigf_TpetraCrsMatrix_globalAssemble(self) subroutine swigf_TpetraCrsMatrix_resumeFill__SWIG_0(self, params) use, intrinsic :: ISO_C_BINDING -class(TpetraCrsMatrix), intent(inout) :: self - +class(TpetraCrsMatrix), intent(in) :: self class(ParameterList), intent(in) :: params - type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 @@ -9828,8 +9410,7 @@ subroutine swigf_TpetraCrsMatrix_resumeFill__SWIG_0(self, params) subroutine swigf_TpetraCrsMatrix_resumeFill__SWIG_1(self) use, intrinsic :: ISO_C_BINDING -class(TpetraCrsMatrix), intent(inout) :: self - +class(TpetraCrsMatrix), intent(in) :: self type(SwigClassWrapper) :: farg1 farg1 = self%swigdata @@ -9838,14 +9419,10 @@ subroutine swigf_TpetraCrsMatrix_resumeFill__SWIG_1(self) subroutine swigf_TpetraCrsMatrix_fillComplete__SWIG_0(self, domainmap, rangemap, params) use, intrinsic :: ISO_C_BINDING -class(TpetraCrsMatrix), intent(inout) :: self - +class(TpetraCrsMatrix), intent(in) :: self class(TpetraMap), intent(in) :: domainmap - class(TpetraMap), intent(in) :: rangemap - class(ParameterList), intent(in) :: params - type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 type(SwigClassWrapper) :: farg3 @@ -9860,12 +9437,9 @@ subroutine swigf_TpetraCrsMatrix_fillComplete__SWIG_0(self, domainmap, rangemap, subroutine swigf_TpetraCrsMatrix_fillComplete__SWIG_1(self, domainmap, rangemap) use, intrinsic :: ISO_C_BINDING -class(TpetraCrsMatrix), intent(inout) :: self - +class(TpetraCrsMatrix), intent(in) :: self class(TpetraMap), intent(in) :: domainmap - class(TpetraMap), intent(in) :: rangemap - type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 type(SwigClassWrapper) :: farg3 @@ -9878,10 +9452,8 @@ subroutine swigf_TpetraCrsMatrix_fillComplete__SWIG_1(self, domainmap, rangemap) subroutine swigf_TpetraCrsMatrix_fillComplete__SWIG_2(self, params) use, intrinsic :: ISO_C_BINDING -class(TpetraCrsMatrix), intent(inout) :: self - +class(TpetraCrsMatrix), intent(in) :: self class(ParameterList), intent(in) :: params - type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 @@ -9892,8 +9464,7 @@ subroutine swigf_TpetraCrsMatrix_fillComplete__SWIG_2(self, params) subroutine swigf_TpetraCrsMatrix_fillComplete__SWIG_3(self) use, intrinsic :: ISO_C_BINDING -class(TpetraCrsMatrix), intent(inout) :: self - +class(TpetraCrsMatrix), intent(in) :: self type(SwigClassWrapper) :: farg1 farg1 = self%swigdata @@ -9902,18 +9473,12 @@ subroutine swigf_TpetraCrsMatrix_fillComplete__SWIG_3(self) subroutine swigf_TpetraCrsMatrix_expertStaticFillComplete__SWIG_0(self, domainmap, rangemap, importer, exporter, params) use, intrinsic :: ISO_C_BINDING -class(TpetraCrsMatrix), intent(inout) :: self - +class(TpetraCrsMatrix), intent(in) :: self class(TpetraMap), intent(in) :: domainmap - class(TpetraMap), intent(in) :: rangemap - class(TpetraImport), intent(in) :: importer - class(TpetraExport), intent(in) :: exporter - class(ParameterList), intent(in) :: params - type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 type(SwigClassWrapper) :: farg3 @@ -9932,16 +9497,11 @@ subroutine swigf_TpetraCrsMatrix_expertStaticFillComplete__SWIG_0(self, domainma subroutine swigf_TpetraCrsMatrix_expertStaticFillComplete__SWIG_1(self, domainmap, rangemap, importer, exporter) use, intrinsic :: ISO_C_BINDING -class(TpetraCrsMatrix), intent(inout) :: self - +class(TpetraCrsMatrix), intent(in) :: self class(TpetraMap), intent(in) :: domainmap - class(TpetraMap), intent(in) :: rangemap - class(TpetraImport), intent(in) :: importer - class(TpetraExport), intent(in) :: exporter - type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 type(SwigClassWrapper) :: farg3 @@ -9958,14 +9518,10 @@ subroutine swigf_TpetraCrsMatrix_expertStaticFillComplete__SWIG_1(self, domainma subroutine swigf_TpetraCrsMatrix_expertStaticFillComplete__SWIG_2(self, domainmap, rangemap, importer) use, intrinsic :: ISO_C_BINDING -class(TpetraCrsMatrix), intent(inout) :: self - +class(TpetraCrsMatrix), intent(in) :: self class(TpetraMap), intent(in) :: domainmap - class(TpetraMap), intent(in) :: rangemap - class(TpetraImport), intent(in) :: importer - type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 type(SwigClassWrapper) :: farg3 @@ -9980,12 +9536,9 @@ subroutine swigf_TpetraCrsMatrix_expertStaticFillComplete__SWIG_2(self, domainma subroutine swigf_TpetraCrsMatrix_expertStaticFillComplete__SWIG_3(self, domainmap, rangemap) use, intrinsic :: ISO_C_BINDING -class(TpetraCrsMatrix), intent(inout) :: self - +class(TpetraCrsMatrix), intent(in) :: self class(TpetraMap), intent(in) :: domainmap - class(TpetraMap), intent(in) :: rangemap - type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 type(SwigClassWrapper) :: farg3 @@ -9998,10 +9551,8 @@ subroutine swigf_TpetraCrsMatrix_expertStaticFillComplete__SWIG_3(self, domainma subroutine swigf_TpetraCrsMatrix_replaceColMap(self, newcolmap) use, intrinsic :: ISO_C_BINDING -class(TpetraCrsMatrix), intent(inout) :: self - +class(TpetraCrsMatrix), intent(in) :: self class(TpetraMap), intent(in) :: newcolmap - type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 @@ -10012,16 +9563,11 @@ subroutine swigf_TpetraCrsMatrix_replaceColMap(self, newcolmap) subroutine swigf_TpetraCrsMatrix_reindexColumns__SWIG_0(self, graph, newcolmap, newimport, sorteachrow) use, intrinsic :: ISO_C_BINDING -class(TpetraCrsMatrix), intent(inout) :: self - -class(TpetraCrsGraph), intent(inout) :: graph - +class(TpetraCrsMatrix), intent(in) :: self +class(TpetraCrsGraph), intent(in) :: graph class(TpetraMap), intent(in) :: newcolmap - class(TpetraImport), intent(in) :: newimport - logical, intent(in) :: sorteachrow - type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 type(SwigClassWrapper) :: farg3 @@ -10038,14 +9584,10 @@ subroutine swigf_TpetraCrsMatrix_reindexColumns__SWIG_0(self, graph, newcolmap, subroutine swigf_TpetraCrsMatrix_reindexColumns__SWIG_1(self, graph, newcolmap, newimport) use, intrinsic :: ISO_C_BINDING -class(TpetraCrsMatrix), intent(inout) :: self - -class(TpetraCrsGraph), intent(inout) :: graph - +class(TpetraCrsMatrix), intent(in) :: self +class(TpetraCrsGraph), intent(in) :: graph class(TpetraMap), intent(in) :: newcolmap - class(TpetraImport), intent(in) :: newimport - type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 type(SwigClassWrapper) :: farg3 @@ -10060,12 +9602,9 @@ subroutine swigf_TpetraCrsMatrix_reindexColumns__SWIG_1(self, graph, newcolmap, subroutine swigf_TpetraCrsMatrix_reindexColumns__SWIG_2(self, graph, newcolmap) use, intrinsic :: ISO_C_BINDING -class(TpetraCrsMatrix), intent(inout) :: self - -class(TpetraCrsGraph), intent(inout) :: graph - +class(TpetraCrsMatrix), intent(in) :: self +class(TpetraCrsGraph), intent(in) :: graph class(TpetraMap), intent(in) :: newcolmap - type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 type(SwigClassWrapper) :: farg3 @@ -10078,12 +9617,9 @@ subroutine swigf_TpetraCrsMatrix_reindexColumns__SWIG_2(self, graph, newcolmap) subroutine swigf_TpetraCrsMatrix_replaceDomainMapAndImporter(self, newdomainmap, newimporter) use, intrinsic :: ISO_C_BINDING -class(TpetraCrsMatrix), intent(inout) :: self - +class(TpetraCrsMatrix), intent(in) :: self class(TpetraMap), intent(in) :: newdomainmap - -class(TpetraImport), intent(inout) :: newimporter - +class(TpetraImport), intent(in) :: newimporter type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 type(SwigClassWrapper) :: farg3 @@ -10096,10 +9632,8 @@ subroutine swigf_TpetraCrsMatrix_replaceDomainMapAndImporter(self, newdomainmap, subroutine swigf_TpetraCrsMatrix_removeEmptyProcessesInPlace(self, newmap) use, intrinsic :: ISO_C_BINDING -class(TpetraCrsMatrix), intent(inout) :: self - +class(TpetraCrsMatrix), intent(in) :: self class(TpetraMap), intent(in) :: newmap - type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 @@ -10113,7 +9647,6 @@ function swigf_TpetraCrsMatrix_getComm(self) & use, intrinsic :: ISO_C_BINDING type(TeuchosComm) :: swig_result class(TpetraCrsMatrix), intent(in) :: self - type(SwigClassWrapper) :: fresult type(SwigClassWrapper) :: farg1 @@ -10127,7 +9660,6 @@ function swigf_TpetraCrsMatrix_getRowMap(self) & use, intrinsic :: ISO_C_BINDING type(TpetraMap) :: swig_result class(TpetraCrsMatrix), intent(in) :: self - type(SwigClassWrapper) :: fresult type(SwigClassWrapper) :: farg1 @@ -10141,7 +9673,6 @@ function swigf_TpetraCrsMatrix_getColMap(self) & use, intrinsic :: ISO_C_BINDING type(TpetraMap) :: swig_result class(TpetraCrsMatrix), intent(in) :: self - type(SwigClassWrapper) :: fresult type(SwigClassWrapper) :: farg1 @@ -10155,7 +9686,6 @@ function swigf_TpetraCrsMatrix_getCrsGraph(self) & use, intrinsic :: ISO_C_BINDING type(TpetraCrsGraph) :: swig_result class(TpetraCrsMatrix), intent(in) :: self - type(SwigClassWrapper) :: fresult type(SwigClassWrapper) :: farg1 @@ -10169,7 +9699,6 @@ function swigf_TpetraCrsMatrix_getGlobalNumRows(self) & use, intrinsic :: ISO_C_BINDING integer(C_LONG) :: swig_result class(TpetraCrsMatrix), intent(in) :: self - integer(C_LONG) :: fresult type(SwigClassWrapper) :: farg1 @@ -10183,7 +9712,6 @@ function swigf_TpetraCrsMatrix_getGlobalNumCols(self) & use, intrinsic :: ISO_C_BINDING integer(C_LONG) :: swig_result class(TpetraCrsMatrix), intent(in) :: self - integer(C_LONG) :: fresult type(SwigClassWrapper) :: farg1 @@ -10197,7 +9725,6 @@ function swigf_TpetraCrsMatrix_getNodeNumRows(self) & use, intrinsic :: ISO_C_BINDING integer(C_SIZE_T) :: swig_result class(TpetraCrsMatrix), intent(in) :: self - integer(C_SIZE_T) :: fresult type(SwigClassWrapper) :: farg1 @@ -10211,7 +9738,6 @@ function swigf_TpetraCrsMatrix_getNodeNumCols(self) & use, intrinsic :: ISO_C_BINDING integer(C_SIZE_T) :: swig_result class(TpetraCrsMatrix), intent(in) :: self - integer(C_SIZE_T) :: fresult type(SwigClassWrapper) :: farg1 @@ -10225,7 +9751,6 @@ function swigf_TpetraCrsMatrix_getGlobalNumEntries(self) & use, intrinsic :: ISO_C_BINDING integer(C_LONG) :: swig_result class(TpetraCrsMatrix), intent(in) :: self - integer(C_LONG) :: fresult type(SwigClassWrapper) :: farg1 @@ -10239,7 +9764,6 @@ function swigf_TpetraCrsMatrix_getNodeNumEntries(self) & use, intrinsic :: ISO_C_BINDING integer(C_SIZE_T) :: swig_result class(TpetraCrsMatrix), intent(in) :: self - integer(C_SIZE_T) :: fresult type(SwigClassWrapper) :: farg1 @@ -10253,9 +9777,7 @@ function swigf_TpetraCrsMatrix_getNumEntriesInGlobalRow(self, globalrow) & use, intrinsic :: ISO_C_BINDING integer(C_SIZE_T) :: swig_result class(TpetraCrsMatrix), intent(in) :: self - integer(C_LONG_LONG), intent(in) :: globalrow - integer(C_SIZE_T) :: fresult type(SwigClassWrapper) :: farg1 integer(C_LONG_LONG) :: farg2 @@ -10271,9 +9793,7 @@ function swigf_TpetraCrsMatrix_getNumEntriesInLocalRow(self, localrow) & use, intrinsic :: ISO_C_BINDING integer :: swig_result class(TpetraCrsMatrix), intent(in) :: self - integer, intent(in) :: localrow - integer(C_INT) :: fresult type(SwigClassWrapper) :: farg1 integer(C_INT) :: farg2 @@ -10289,7 +9809,6 @@ function swigf_TpetraCrsMatrix_getGlobalMaxNumRowEntries(self) & use, intrinsic :: ISO_C_BINDING integer(C_SIZE_T) :: swig_result class(TpetraCrsMatrix), intent(in) :: self - integer(C_SIZE_T) :: fresult type(SwigClassWrapper) :: farg1 @@ -10303,7 +9822,6 @@ function swigf_TpetraCrsMatrix_getNodeMaxNumRowEntries(self) & use, intrinsic :: ISO_C_BINDING integer(C_SIZE_T) :: swig_result class(TpetraCrsMatrix), intent(in) :: self - integer(C_SIZE_T) :: fresult type(SwigClassWrapper) :: farg1 @@ -10317,7 +9835,6 @@ function swigf_TpetraCrsMatrix_hasColMap(self) & use, intrinsic :: ISO_C_BINDING logical :: swig_result class(TpetraCrsMatrix), intent(in) :: self - integer(C_INT) :: fresult type(SwigClassWrapper) :: farg1 @@ -10331,7 +9848,6 @@ function swigf_TpetraCrsMatrix_isLocallyIndexed(self) & use, intrinsic :: ISO_C_BINDING logical :: swig_result class(TpetraCrsMatrix), intent(in) :: self - integer(C_INT) :: fresult type(SwigClassWrapper) :: farg1 @@ -10345,7 +9861,6 @@ function swigf_TpetraCrsMatrix_isGloballyIndexed(self) & use, intrinsic :: ISO_C_BINDING logical :: swig_result class(TpetraCrsMatrix), intent(in) :: self - integer(C_INT) :: fresult type(SwigClassWrapper) :: farg1 @@ -10359,7 +9874,6 @@ function swigf_TpetraCrsMatrix_isFillComplete(self) & use, intrinsic :: ISO_C_BINDING logical :: swig_result class(TpetraCrsMatrix), intent(in) :: self - integer(C_INT) :: fresult type(SwigClassWrapper) :: farg1 @@ -10373,7 +9887,6 @@ function swigf_TpetraCrsMatrix_isFillActive(self) & use, intrinsic :: ISO_C_BINDING logical :: swig_result class(TpetraCrsMatrix), intent(in) :: self - integer(C_INT) :: fresult type(SwigClassWrapper) :: farg1 @@ -10387,7 +9900,6 @@ function swigf_TpetraCrsMatrix_isStorageOptimized(self) & use, intrinsic :: ISO_C_BINDING logical :: swig_result class(TpetraCrsMatrix), intent(in) :: self - integer(C_INT) :: fresult type(SwigClassWrapper) :: farg1 @@ -10401,7 +9913,6 @@ function swigf_TpetraCrsMatrix_getProfileType(self) & use, intrinsic :: ISO_C_BINDING integer(TpetraProfileType) :: swig_result class(TpetraCrsMatrix), intent(in) :: self - integer(C_INT) :: fresult type(SwigClassWrapper) :: farg1 @@ -10415,7 +9926,6 @@ function swigf_TpetraCrsMatrix_isStaticGraph(self) & use, intrinsic :: ISO_C_BINDING logical :: swig_result class(TpetraCrsMatrix), intent(in) :: self - integer(C_INT) :: fresult type(SwigClassWrapper) :: farg1 @@ -10429,7 +9939,6 @@ function swigf_TpetraCrsMatrix_getFrobeniusNorm(self) & use, intrinsic :: ISO_C_BINDING real(C_DOUBLE) :: swig_result class(TpetraCrsMatrix), intent(in) :: self - real(C_DOUBLE) :: fresult type(SwigClassWrapper) :: farg1 @@ -10443,7 +9952,6 @@ function swigf_TpetraCrsMatrix_supportsRowViews(self) & use, intrinsic :: ISO_C_BINDING logical :: swig_result class(TpetraCrsMatrix), intent(in) :: self - integer(C_INT) :: fresult type(SwigClassWrapper) :: farg1 @@ -10455,14 +9963,12 @@ function swigf_TpetraCrsMatrix_supportsRowViews(self) & subroutine swigf_TpetraCrsMatrix_getGlobalRowCopy(self, globalrow, indices, values, numentries) use, intrinsic :: ISO_C_BINDING class(TpetraCrsMatrix), intent(in) :: self - integer(C_LONG_LONG), intent(in) :: globalrow integer(C_LONG_LONG), dimension(:), target :: indices integer(C_LONG_LONG), pointer :: farg3_view real(C_DOUBLE), dimension(:), target :: values real(C_DOUBLE), pointer :: farg4_view integer(C_SIZE_T), target, intent(inout) :: numentries - type(SwigClassWrapper) :: farg1 integer(C_LONG_LONG) :: farg2 type(SwigArrayWrapper) :: farg3 @@ -10494,14 +10000,12 @@ subroutine swigf_TpetraCrsMatrix_getGlobalRowCopy(self, globalrow, indices, valu subroutine swigf_TpetraCrsMatrix_getLocalRowCopy(self, localrow, colinds, vals, numentries) use, intrinsic :: ISO_C_BINDING class(TpetraCrsMatrix), intent(in) :: self - integer, intent(in) :: localrow integer(C_INT), dimension(:), target :: colinds integer(C_INT), pointer :: farg3_view real(C_DOUBLE), dimension(:), target :: vals real(C_DOUBLE), pointer :: farg4_view integer(C_SIZE_T), target, intent(inout) :: numentries - type(SwigClassWrapper) :: farg1 integer(C_INT) :: farg2 type(SwigArrayWrapper) :: farg3 @@ -10533,11 +10037,9 @@ subroutine swigf_TpetraCrsMatrix_getLocalRowCopy(self, localrow, colinds, vals, subroutine swigf_TpetraCrsMatrix_getGlobalRowView(self, globalrow, indices, values) use, intrinsic :: ISO_C_BINDING class(TpetraCrsMatrix), intent(in) :: self - integer(C_LONG_LONG), intent(in) :: globalrow integer(C_LONG_LONG), dimension(:), pointer, intent(inout) :: indices real(C_DOUBLE), dimension(:), pointer, intent(inout) :: values - type(SwigClassWrapper) :: farg1 integer(C_LONG_LONG) :: farg2 type(SwigArrayWrapper) :: farg3 @@ -10575,9 +10077,7 @@ subroutine swigf_TpetraCrsMatrix_getGlobalRowView(self, globalrow, indices, valu subroutine swigf_TpetraCrsMatrix_getLocalDiagOffsets(self, offsets) use, intrinsic :: ISO_C_BINDING class(TpetraCrsMatrix), intent(in) :: self - -class(SWIGTYPE_Teuchos__ArrayRCPT_unsigned_long_t), intent(inout) :: offsets - +class(SWIGTYPE_Teuchos__ArrayRCPT_unsigned_long_t), intent(in) :: offsets type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 @@ -10589,15 +10089,11 @@ subroutine swigf_TpetraCrsMatrix_getLocalDiagOffsets(self, offsets) subroutine swigf_TpetraCrsMatrix_apply__SWIG_0(self, x, y, mode, alpha, beta) use, intrinsic :: ISO_C_BINDING class(TpetraCrsMatrix), intent(in) :: self - class(TpetraMultiVector), intent(in) :: x - -class(TpetraMultiVector), intent(inout) :: y - +class(TpetraMultiVector), intent(in) :: y integer(TeuchosETransp), intent(in) :: mode real(C_DOUBLE), intent(in) :: alpha real(C_DOUBLE), intent(in) :: beta - type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 type(SwigClassWrapper) :: farg3 @@ -10617,14 +10113,10 @@ subroutine swigf_TpetraCrsMatrix_apply__SWIG_0(self, x, y, mode, alpha, beta) subroutine swigf_TpetraCrsMatrix_apply__SWIG_1(self, x, y, mode, alpha) use, intrinsic :: ISO_C_BINDING class(TpetraCrsMatrix), intent(in) :: self - class(TpetraMultiVector), intent(in) :: x - -class(TpetraMultiVector), intent(inout) :: y - +class(TpetraMultiVector), intent(in) :: y integer(TeuchosETransp), intent(in) :: mode real(C_DOUBLE), intent(in) :: alpha - type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 type(SwigClassWrapper) :: farg3 @@ -10642,13 +10134,9 @@ subroutine swigf_TpetraCrsMatrix_apply__SWIG_1(self, x, y, mode, alpha) subroutine swigf_TpetraCrsMatrix_apply__SWIG_2(self, x, y, mode) use, intrinsic :: ISO_C_BINDING class(TpetraCrsMatrix), intent(in) :: self - class(TpetraMultiVector), intent(in) :: x - -class(TpetraMultiVector), intent(inout) :: y - +class(TpetraMultiVector), intent(in) :: y integer(TeuchosETransp), intent(in) :: mode - type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 type(SwigClassWrapper) :: farg3 @@ -10664,11 +10152,8 @@ subroutine swigf_TpetraCrsMatrix_apply__SWIG_2(self, x, y, mode) subroutine swigf_TpetraCrsMatrix_apply__SWIG_3(self, x, y) use, intrinsic :: ISO_C_BINDING class(TpetraCrsMatrix), intent(in) :: self - class(TpetraMultiVector), intent(in) :: x - -class(TpetraMultiVector), intent(inout) :: y - +class(TpetraMultiVector), intent(in) :: y type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 type(SwigClassWrapper) :: farg3 @@ -10684,7 +10169,6 @@ function swigf_TpetraCrsMatrix_hasTransposeApply(self) & use, intrinsic :: ISO_C_BINDING logical :: swig_result class(TpetraCrsMatrix), intent(in) :: self - integer(C_INT) :: fresult type(SwigClassWrapper) :: farg1 @@ -10698,7 +10182,6 @@ function swigf_TpetraCrsMatrix_getDomainMap(self) & use, intrinsic :: ISO_C_BINDING type(TpetraMap) :: swig_result class(TpetraCrsMatrix), intent(in) :: self - type(SwigClassWrapper) :: fresult type(SwigClassWrapper) :: farg1 @@ -10712,7 +10195,6 @@ function swigf_TpetraCrsMatrix_getRangeMap(self) & use, intrinsic :: ISO_C_BINDING type(TpetraMap) :: swig_result class(TpetraCrsMatrix), intent(in) :: self - type(SwigClassWrapper) :: fresult type(SwigClassWrapper) :: farg1 @@ -10724,17 +10206,12 @@ function swigf_TpetraCrsMatrix_getRangeMap(self) & subroutine swigf_TpetraCrsMatrix_gaussSeidel(self, b, x, d, dampingfactor, direction, numsweeps) use, intrinsic :: ISO_C_BINDING class(TpetraCrsMatrix), intent(in) :: self - class(TpetraMultiVector), intent(in) :: b - -class(TpetraMultiVector), intent(inout) :: x - +class(TpetraMultiVector), intent(in) :: x class(TpetraMultiVector), intent(in) :: d - real(C_DOUBLE), intent(in) :: dampingfactor integer(TpetraESweepDirection), intent(in) :: direction integer, intent(in) :: numsweeps - type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 type(SwigClassWrapper) :: farg3 @@ -10756,18 +10233,13 @@ subroutine swigf_TpetraCrsMatrix_gaussSeidel(self, b, x, d, dampingfactor, direc subroutine swigf_TpetraCrsMatrix_gaussSeidelCopy(self, x, b, d, dampingfactor, direction, numsweeps, zeroinitialguess) use, intrinsic :: ISO_C_BINDING class(TpetraCrsMatrix), intent(in) :: self - -class(TpetraMultiVector), intent(inout) :: x - +class(TpetraMultiVector), intent(in) :: x class(TpetraMultiVector), intent(in) :: b - class(TpetraMultiVector), intent(in) :: d - real(C_DOUBLE), intent(in) :: dampingfactor integer(TpetraESweepDirection), intent(in) :: direction integer, intent(in) :: numsweeps logical, intent(in) :: zeroinitialguess - type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 type(SwigClassWrapper) :: farg3 @@ -10793,7 +10265,6 @@ function swigf_TpetraCrsMatrix_description(self) & use, intrinsic :: ISO_C_BINDING character(kind=C_CHAR, len=:), allocatable :: swig_result class(TpetraCrsMatrix), intent(in) :: self - type(SwigArrayWrapper) :: fresult type(SwigClassWrapper) :: farg1 @@ -10806,17 +10277,11 @@ function swigf_TpetraCrsMatrix_description(self) & subroutine swigf_TpetraCrsMatrix_importAndFillComplete__SWIG_0(self, destmatrix, importer, domainmap, rangemap, params) use, intrinsic :: ISO_C_BINDING class(TpetraCrsMatrix), intent(in) :: self - -class(TpetraCrsMatrix), intent(inout) :: destmatrix - +class(TpetraCrsMatrix), intent(in) :: destmatrix class(TpetraImport), intent(in) :: importer - class(TpetraMap), intent(in) :: domainmap - class(TpetraMap), intent(in) :: rangemap - class(ParameterList), intent(in) :: params - type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 type(SwigClassWrapper) :: farg3 @@ -10836,15 +10301,10 @@ subroutine swigf_TpetraCrsMatrix_importAndFillComplete__SWIG_0(self, destmatrix, subroutine swigf_TpetraCrsMatrix_importAndFillComplete__SWIG_1(self, destmatrix, importer, domainmap, rangemap) use, intrinsic :: ISO_C_BINDING class(TpetraCrsMatrix), intent(in) :: self - -class(TpetraCrsMatrix), intent(inout) :: destmatrix - +class(TpetraCrsMatrix), intent(in) :: destmatrix class(TpetraImport), intent(in) :: importer - class(TpetraMap), intent(in) :: domainmap - class(TpetraMap), intent(in) :: rangemap - type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 type(SwigClassWrapper) :: farg3 @@ -10863,19 +10323,12 @@ subroutine swigf_TpetraCrsMatrix_importAndFillComplete__SWIG_2(self, destmatrix, rangemap, params) use, intrinsic :: ISO_C_BINDING class(TpetraCrsMatrix), intent(in) :: self - -class(TpetraCrsMatrix), intent(inout) :: destmatrix - +class(TpetraCrsMatrix), intent(in) :: destmatrix class(TpetraImport), intent(in) :: rowimporter - class(TpetraImport), intent(in) :: domainimporter - class(TpetraMap), intent(in) :: domainmap - class(TpetraMap), intent(in) :: rangemap - class(ParameterList), intent(in) :: params - type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 type(SwigClassWrapper) :: farg3 @@ -10897,17 +10350,11 @@ subroutine swigf_TpetraCrsMatrix_importAndFillComplete__SWIG_2(self, destmatrix, subroutine swigf_TpetraCrsMatrix_exportAndFillComplete__SWIG_0(self, destmatrix, exporter, domainmap, rangemap, params) use, intrinsic :: ISO_C_BINDING class(TpetraCrsMatrix), intent(in) :: self - -class(TpetraCrsMatrix), intent(inout) :: destmatrix - +class(TpetraCrsMatrix), intent(in) :: destmatrix class(TpetraExport), intent(in) :: exporter - class(TpetraMap), intent(in) :: domainmap - class(TpetraMap), intent(in) :: rangemap - class(ParameterList), intent(in) :: params - type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 type(SwigClassWrapper) :: farg3 @@ -10927,15 +10374,10 @@ subroutine swigf_TpetraCrsMatrix_exportAndFillComplete__SWIG_0(self, destmatrix, subroutine swigf_TpetraCrsMatrix_exportAndFillComplete__SWIG_1(self, destmatrix, exporter, domainmap, rangemap) use, intrinsic :: ISO_C_BINDING class(TpetraCrsMatrix), intent(in) :: self - -class(TpetraCrsMatrix), intent(inout) :: destmatrix - +class(TpetraCrsMatrix), intent(in) :: destmatrix class(TpetraExport), intent(in) :: exporter - class(TpetraMap), intent(in) :: domainmap - class(TpetraMap), intent(in) :: rangemap - type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 type(SwigClassWrapper) :: farg3 @@ -10953,13 +10395,9 @@ subroutine swigf_TpetraCrsMatrix_exportAndFillComplete__SWIG_1(self, destmatrix, subroutine swigf_TpetraCrsMatrix_exportAndFillComplete__SWIG_2(self, destmatrix, exporter, domainmap) use, intrinsic :: ISO_C_BINDING class(TpetraCrsMatrix), intent(in) :: self - -class(TpetraCrsMatrix), intent(inout) :: destmatrix - +class(TpetraCrsMatrix), intent(in) :: destmatrix class(TpetraExport), intent(in) :: exporter - class(TpetraMap), intent(in) :: domainmap - type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 type(SwigClassWrapper) :: farg3 @@ -10975,11 +10413,8 @@ subroutine swigf_TpetraCrsMatrix_exportAndFillComplete__SWIG_2(self, destmatrix, subroutine swigf_TpetraCrsMatrix_exportAndFillComplete__SWIG_3(self, destmatrix, exporter) use, intrinsic :: ISO_C_BINDING class(TpetraCrsMatrix), intent(in) :: self - -class(TpetraCrsMatrix), intent(inout) :: destmatrix - +class(TpetraCrsMatrix), intent(in) :: destmatrix class(TpetraExport), intent(in) :: exporter - type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 type(SwigClassWrapper) :: farg3 @@ -10994,19 +10429,12 @@ subroutine swigf_TpetraCrsMatrix_exportAndFillComplete__SWIG_4(self, destmatrix, rangemap, params) use, intrinsic :: ISO_C_BINDING class(TpetraCrsMatrix), intent(in) :: self - -class(TpetraCrsMatrix), intent(inout) :: destmatrix - +class(TpetraCrsMatrix), intent(in) :: destmatrix class(TpetraExport), intent(in) :: rowexporter - class(TpetraExport), intent(in) :: domainexporter - class(TpetraMap), intent(in) :: domainmap - class(TpetraMap), intent(in) :: rangemap - class(ParameterList), intent(in) :: params - type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 type(SwigClassWrapper) :: farg3 @@ -11027,8 +10455,7 @@ subroutine swigf_TpetraCrsMatrix_exportAndFillComplete__SWIG_4(self, destmatrix, subroutine swigf_TpetraCrsMatrix_computeGlobalConstants(self) use, intrinsic :: ISO_C_BINDING -class(TpetraCrsMatrix), intent(inout) :: self - +class(TpetraCrsMatrix), intent(in) :: self type(SwigClassWrapper) :: farg1 farg1 = self%swigdata @@ -11040,7 +10467,6 @@ function swigf_TpetraCrsMatrix_haveGlobalConstants(self) & use, intrinsic :: ISO_C_BINDING logical :: swig_result class(TpetraCrsMatrix), intent(in) :: self - integer(C_INT) :: fresult type(SwigClassWrapper) :: farg1 @@ -11052,14 +10478,12 @@ function swigf_TpetraCrsMatrix_haveGlobalConstants(self) & subroutine swigf_TpetraCrsMatrix_getAllValues(self, rowpointers, columnindices, values) use, intrinsic :: ISO_C_BINDING class(TpetraCrsMatrix), intent(in) :: self - integer(C_LONG), dimension(:), target :: rowpointers integer(C_LONG), pointer :: farg2_view integer(C_INT), dimension(:), target :: columnindices integer(C_INT), pointer :: farg3_view real(C_DOUBLE), dimension(:), target :: values real(C_DOUBLE), pointer :: farg4_view - type(SwigClassWrapper) :: farg1 type(SwigArrayWrapper) :: farg2 type(SwigArrayWrapper) :: farg3 @@ -11093,18 +10517,24 @@ subroutine swigf_TpetraCrsMatrix_getAllValues(self, rowpointers, columnindices, call swigc_TpetraCrsMatrix_getAllValues(farg1, farg2, farg3, farg4) end subroutine - subroutine swigf_assignment_TpetraCrsMatrix(self, other) - use, intrinsic :: ISO_C_BINDING - class(TpetraCrsMatrix), intent(inout) :: self - type(TpetraCrsMatrix), intent(in) :: other - call swigc_assignment_TpetraCrsMatrix(self%swigdata, other%swigdata) - end subroutine +subroutine swigf_TpetraCrsMatrix_op_assign__(self, other) +use, intrinsic :: ISO_C_BINDING +class(TpetraCrsMatrix), intent(inout) :: self +type(SWIGTYPE_Tpetra__CrsMatrixT_SC_LO_GO_NO_t), intent(in) :: other +type(SwigClassWrapper) :: farg1 +type(SwigClassWrapper) :: farg2 + +farg1 = self%swigdata +farg2 = other%swigdata +call swigc_TpetraCrsMatrix_op_assign__(farg1, farg2) +self%swigdata = farg1 +end subroutine + function operator_to_matrix(op) & result(swig_result) use, intrinsic :: ISO_C_BINDING type(TpetraCrsMatrix) :: swig_result -class(TpetraOperator), intent(inout) :: op - +class(TpetraOperator), intent(in) :: op type(SwigClassWrapper) :: fresult type(SwigClassWrapper) :: farg1 @@ -11117,8 +10547,7 @@ function matrix_to_operator(a) & result(swig_result) use, intrinsic :: ISO_C_BINDING type(TpetraOperator) :: swig_result -class(TpetraCrsMatrix), intent(inout) :: a - +class(TpetraCrsMatrix), intent(in) :: a type(SwigClassWrapper) :: fresult type(SwigClassWrapper) :: farg1 @@ -11127,16 +10556,14 @@ function matrix_to_operator(a) & swig_result%swigdata = fresult end function -function TpetraReader_readSparseGraphFile__SWIG_0(filename, pcomm, callfillcomplete) & +function swigf_TpetraReader_readSparseGraphFile__SWIG_0(filename, pcomm, callfillcomplete) & result(swig_result) use, intrinsic :: ISO_C_BINDING type(TpetraCrsGraph) :: swig_result character(kind=C_CHAR, len=*), target :: filename character(kind=C_CHAR), dimension(:), allocatable, target :: farg1_chars class(TeuchosComm), intent(in) :: pcomm - logical, intent(in) :: callfillcomplete - type(SwigClassWrapper) :: fresult type(SwigArrayWrapper) :: farg1 type(SwigClassWrapper) :: farg2 @@ -11149,14 +10576,13 @@ function TpetraReader_readSparseGraphFile__SWIG_0(filename, pcomm, callfillcompl swig_result%swigdata = fresult end function -function TpetraReader_readSparseGraphFile__SWIG_1(filename, pcomm) & +function swigf_TpetraReader_readSparseGraphFile__SWIG_1(filename, pcomm) & result(swig_result) use, intrinsic :: ISO_C_BINDING type(TpetraCrsGraph) :: swig_result character(kind=C_CHAR, len=*), target :: filename character(kind=C_CHAR), dimension(:), allocatable, target :: farg1_chars class(TeuchosComm), intent(in) :: pcomm - type(SwigClassWrapper) :: fresult type(SwigArrayWrapper) :: farg1 type(SwigClassWrapper) :: farg2 @@ -11167,18 +10593,15 @@ function TpetraReader_readSparseGraphFile__SWIG_1(filename, pcomm) & swig_result%swigdata = fresult end function -function TpetraReader_readSparseGraphFile__SWIG_2(filename, pcomm, constructorparams, fillcompleteparams) & +function swigf_TpetraReader_readSparseGraphFile__SWIG_2(filename, pcomm, constructorparams, fillcompleteparams) & result(swig_result) use, intrinsic :: ISO_C_BINDING type(TpetraCrsGraph) :: swig_result character(kind=C_CHAR, len=*), target :: filename character(kind=C_CHAR), dimension(:), allocatable, target :: farg1_chars class(TeuchosComm), intent(in) :: pcomm - class(ParameterList), intent(in) :: constructorparams - class(ParameterList), intent(in) :: fillcompleteparams - type(SwigClassWrapper) :: fresult type(SwigArrayWrapper) :: farg1 type(SwigClassWrapper) :: farg2 @@ -11193,22 +10616,17 @@ function TpetraReader_readSparseGraphFile__SWIG_2(filename, pcomm, constructorpa swig_result%swigdata = fresult end function -function TpetraReader_readSparseGraphFile__SWIG_3(filename, rowmap, colmap, domainmap, rangemap, callfillcomplete) & +function swigf_TpetraReader_readSparseGraphFile__SWIG_3(filename, rowmap, colmap, domainmap, rangemap, callfillcomplete) & result(swig_result) use, intrinsic :: ISO_C_BINDING type(TpetraCrsGraph) :: swig_result character(kind=C_CHAR, len=*), target :: filename character(kind=C_CHAR), dimension(:), allocatable, target :: farg1_chars class(TpetraMap), intent(in) :: rowmap - -class(TpetraMap), intent(inout) :: colmap - +class(TpetraMap), intent(in) :: colmap class(TpetraMap), intent(in) :: domainmap - class(TpetraMap), intent(in) :: rangemap - logical, intent(in) :: callfillcomplete - type(SwigClassWrapper) :: fresult type(SwigArrayWrapper) :: farg1 type(SwigClassWrapper) :: farg2 @@ -11227,20 +10645,16 @@ function TpetraReader_readSparseGraphFile__SWIG_3(filename, rowmap, colmap, doma swig_result%swigdata = fresult end function -function TpetraReader_readSparseGraphFile__SWIG_4(filename, rowmap, colmap, domainmap, rangemap) & +function swigf_TpetraReader_readSparseGraphFile__SWIG_4(filename, rowmap, colmap, domainmap, rangemap) & result(swig_result) use, intrinsic :: ISO_C_BINDING type(TpetraCrsGraph) :: swig_result character(kind=C_CHAR, len=*), target :: filename character(kind=C_CHAR), dimension(:), allocatable, target :: farg1_chars class(TpetraMap), intent(in) :: rowmap - -class(TpetraMap), intent(inout) :: colmap - +class(TpetraMap), intent(in) :: colmap class(TpetraMap), intent(in) :: domainmap - class(TpetraMap), intent(in) :: rangemap - type(SwigClassWrapper) :: fresult type(SwigArrayWrapper) :: farg1 type(SwigClassWrapper) :: farg2 @@ -11257,16 +10671,14 @@ function TpetraReader_readSparseGraphFile__SWIG_4(filename, rowmap, colmap, doma swig_result%swigdata = fresult end function -function TpetraReader_readSparseFile__SWIG_0(filename, pcomm, callfillcomplete) & +function swigf_TpetraReader_readSparseFile__SWIG_0(filename, pcomm, callfillcomplete) & result(swig_result) use, intrinsic :: ISO_C_BINDING type(TpetraCrsMatrix) :: swig_result character(kind=C_CHAR, len=*), target :: filename character(kind=C_CHAR), dimension(:), allocatable, target :: farg1_chars class(TeuchosComm), intent(in) :: pcomm - logical, intent(in) :: callfillcomplete - type(SwigClassWrapper) :: fresult type(SwigArrayWrapper) :: farg1 type(SwigClassWrapper) :: farg2 @@ -11279,14 +10691,13 @@ function TpetraReader_readSparseFile__SWIG_0(filename, pcomm, callfillcomplete) swig_result%swigdata = fresult end function -function TpetraReader_readSparseFile__SWIG_1(filename, pcomm) & +function swigf_TpetraReader_readSparseFile__SWIG_1(filename, pcomm) & result(swig_result) use, intrinsic :: ISO_C_BINDING type(TpetraCrsMatrix) :: swig_result character(kind=C_CHAR, len=*), target :: filename character(kind=C_CHAR), dimension(:), allocatable, target :: farg1_chars class(TeuchosComm), intent(in) :: pcomm - type(SwigClassWrapper) :: fresult type(SwigArrayWrapper) :: farg1 type(SwigClassWrapper) :: farg2 @@ -11297,18 +10708,15 @@ function TpetraReader_readSparseFile__SWIG_1(filename, pcomm) & swig_result%swigdata = fresult end function -function TpetraReader_readSparseFile__SWIG_2(filename, pcomm, constructorparams, fillcompleteparams) & +function swigf_TpetraReader_readSparseFile__SWIG_2(filename, pcomm, constructorparams, fillcompleteparams) & result(swig_result) use, intrinsic :: ISO_C_BINDING type(TpetraCrsMatrix) :: swig_result character(kind=C_CHAR, len=*), target :: filename character(kind=C_CHAR), dimension(:), allocatable, target :: farg1_chars class(TeuchosComm), intent(in) :: pcomm - class(ParameterList), intent(in) :: constructorparams - class(ParameterList), intent(in) :: fillcompleteparams - type(SwigClassWrapper) :: fresult type(SwigArrayWrapper) :: farg1 type(SwigClassWrapper) :: farg2 @@ -11323,22 +10731,17 @@ function TpetraReader_readSparseFile__SWIG_2(filename, pcomm, constructorparams, swig_result%swigdata = fresult end function -function TpetraReader_readSparseFile__SWIG_3(filename, rowmap, colmap, domainmap, rangemap, callfillcomplete) & +function swigf_TpetraReader_readSparseFile__SWIG_3(filename, rowmap, colmap, domainmap, rangemap, callfillcomplete) & result(swig_result) use, intrinsic :: ISO_C_BINDING type(TpetraCrsMatrix) :: swig_result character(kind=C_CHAR, len=*), target :: filename character(kind=C_CHAR), dimension(:), allocatable, target :: farg1_chars class(TpetraMap), intent(in) :: rowmap - -class(TpetraMap), intent(inout) :: colmap - +class(TpetraMap), intent(in) :: colmap class(TpetraMap), intent(in) :: domainmap - class(TpetraMap), intent(in) :: rangemap - logical, intent(in) :: callfillcomplete - type(SwigClassWrapper) :: fresult type(SwigArrayWrapper) :: farg1 type(SwigClassWrapper) :: farg2 @@ -11357,20 +10760,16 @@ function TpetraReader_readSparseFile__SWIG_3(filename, rowmap, colmap, domainmap swig_result%swigdata = fresult end function -function TpetraReader_readSparseFile__SWIG_4(filename, rowmap, colmap, domainmap, rangemap) & +function swigf_TpetraReader_readSparseFile__SWIG_4(filename, rowmap, colmap, domainmap, rangemap) & result(swig_result) use, intrinsic :: ISO_C_BINDING type(TpetraCrsMatrix) :: swig_result character(kind=C_CHAR, len=*), target :: filename character(kind=C_CHAR), dimension(:), allocatable, target :: farg1_chars class(TpetraMap), intent(in) :: rowmap - -class(TpetraMap), intent(inout) :: colmap - +class(TpetraMap), intent(in) :: colmap class(TpetraMap), intent(in) :: domainmap - class(TpetraMap), intent(in) :: rangemap - type(SwigClassWrapper) :: fresult type(SwigArrayWrapper) :: farg1 type(SwigClassWrapper) :: farg2 @@ -11387,16 +10786,14 @@ function TpetraReader_readSparseFile__SWIG_4(filename, rowmap, colmap, domainmap swig_result%swigdata = fresult end function -function TpetraReader_readDenseFile(filename, comm, map) & +function swigf_TpetraReader_readDenseFile(filename, comm, map) & result(swig_result) use, intrinsic :: ISO_C_BINDING type(TpetraMultiVector) :: swig_result character(kind=C_CHAR, len=*), target :: filename character(kind=C_CHAR), dimension(:), allocatable, target :: farg1_chars class(TeuchosComm), intent(in) :: comm - -class(TpetraMap), intent(inout) :: map - +class(TpetraMap), intent(in) :: map type(SwigClassWrapper) :: fresult type(SwigArrayWrapper) :: farg1 type(SwigClassWrapper) :: farg2 @@ -11409,14 +10806,13 @@ function TpetraReader_readDenseFile(filename, comm, map) & swig_result%swigdata = fresult end function -function TpetraReader_readMapFile(filename, comm) & +function swigf_TpetraReader_readMapFile(filename, comm) & result(swig_result) use, intrinsic :: ISO_C_BINDING type(TpetraMap) :: swig_result character(kind=C_CHAR, len=*), target :: filename character(kind=C_CHAR), dimension(:), allocatable, target :: farg1_chars class(TeuchosComm), intent(in) :: comm - type(SwigClassWrapper) :: fresult type(SwigArrayWrapper) :: farg1 type(SwigClassWrapper) :: farg2 @@ -11430,7 +10826,6 @@ function TpetraReader_readMapFile(filename, comm) & subroutine delete_TpetraReader(self) use, intrinsic :: ISO_C_BINDING class(TpetraReader), intent(inout) :: self - type(SwigClassWrapper) :: farg1 farg1 = self%swigdata @@ -11441,23 +10836,28 @@ subroutine delete_TpetraReader(self) self%swigdata%mem = SWIG_NULL end subroutine - subroutine swigf_assignment_TpetraReader(self, other) - use, intrinsic :: ISO_C_BINDING - class(TpetraReader), intent(inout) :: self - type(TpetraReader), intent(in) :: other - call swigc_assignment_TpetraReader(self%swigdata, other%swigdata) - end subroutine -subroutine TpetraWriter_writeSparseFile__SWIG_0(filename, pmatrix, matrixname, matrixdescription) +subroutine swigf_TpetraReader_op_assign__(self, other) +use, intrinsic :: ISO_C_BINDING +class(TpetraReader), intent(inout) :: self +type(SWIGTYPE_Tpetra__MatrixMarket__ReaderT_Tpetra__CrsMatrixT_KG2R9), intent(in) :: other +type(SwigClassWrapper) :: farg1 +type(SwigClassWrapper) :: farg2 + +farg1 = self%swigdata +farg2 = other%swigdata +call swigc_TpetraReader_op_assign__(farg1, farg2) +self%swigdata = farg1 +end subroutine + +subroutine swigf_TpetraWriter_writeSparseFile__SWIG_0(filename, pmatrix, matrixname, matrixdescription) use, intrinsic :: ISO_C_BINDING character(kind=C_CHAR, len=*), target :: filename character(kind=C_CHAR), dimension(:), allocatable, target :: farg1_chars class(TpetraCrsMatrix), intent(in) :: pmatrix - character(kind=C_CHAR, len=*), target :: matrixname character(kind=C_CHAR), dimension(:), allocatable, target :: farg3_chars character(kind=C_CHAR, len=*), target :: matrixdescription character(kind=C_CHAR), dimension(:), allocatable, target :: farg4_chars - type(SwigArrayWrapper) :: farg1 type(SwigClassWrapper) :: farg2 type(SwigArrayWrapper) :: farg3 @@ -11470,12 +10870,11 @@ subroutine TpetraWriter_writeSparseFile__SWIG_0(filename, pmatrix, matrixname, m call swigc_TpetraWriter_writeSparseFile__SWIG_0(farg1, farg2, farg3, farg4) end subroutine -subroutine TpetraWriter_writeSparseFile__SWIG_1(filename, pmatrix) +subroutine swigf_TpetraWriter_writeSparseFile__SWIG_1(filename, pmatrix) use, intrinsic :: ISO_C_BINDING character(kind=C_CHAR, len=*), target :: filename character(kind=C_CHAR), dimension(:), allocatable, target :: farg1_chars class(TpetraCrsMatrix), intent(in) :: pmatrix - type(SwigArrayWrapper) :: farg1 type(SwigClassWrapper) :: farg2 @@ -11484,17 +10883,15 @@ subroutine TpetraWriter_writeSparseFile__SWIG_1(filename, pmatrix) call swigc_TpetraWriter_writeSparseFile__SWIG_1(farg1, farg2) end subroutine -subroutine TpetraWriter_writeSparseGraphFile__SWIG_0(filename, pgraph, graphname, graphdescription) +subroutine swigf_TpetraWriter_writeSparseGraphFile__SWIG_0(filename, pgraph, graphname, graphdescription) use, intrinsic :: ISO_C_BINDING character(kind=C_CHAR, len=*), target :: filename character(kind=C_CHAR), dimension(:), allocatable, target :: farg1_chars class(TpetraCrsGraph), intent(in) :: pgraph - character(kind=C_CHAR, len=*), target :: graphname character(kind=C_CHAR), dimension(:), allocatable, target :: farg3_chars character(kind=C_CHAR, len=*), target :: graphdescription character(kind=C_CHAR), dimension(:), allocatable, target :: farg4_chars - type(SwigArrayWrapper) :: farg1 type(SwigClassWrapper) :: farg2 type(SwigArrayWrapper) :: farg3 @@ -11507,12 +10904,11 @@ subroutine TpetraWriter_writeSparseGraphFile__SWIG_0(filename, pgraph, graphname call swigc_TpetraWriter_writeSparseGraphFile__SWIG_0(farg1, farg2, farg3, farg4) end subroutine -subroutine TpetraWriter_writeSparseGraphFile__SWIG_1(filename, pgraph) +subroutine swigf_TpetraWriter_writeSparseGraphFile__SWIG_1(filename, pgraph) use, intrinsic :: ISO_C_BINDING character(kind=C_CHAR, len=*), target :: filename character(kind=C_CHAR), dimension(:), allocatable, target :: farg1_chars class(TpetraCrsGraph), intent(in) :: pgraph - type(SwigArrayWrapper) :: farg1 type(SwigClassWrapper) :: farg2 @@ -11521,17 +10917,15 @@ subroutine TpetraWriter_writeSparseGraphFile__SWIG_1(filename, pgraph) call swigc_TpetraWriter_writeSparseGraphFile__SWIG_1(farg1, farg2) end subroutine -subroutine TpetraWriter_writeDenseFile__SWIG_0(filename, x, matrixname, matrixdescription) +subroutine swigf_TpetraWriter_writeDenseFile__SWIG_0(filename, x, matrixname, matrixdescription) use, intrinsic :: ISO_C_BINDING character(kind=C_CHAR, len=*), target :: filename character(kind=C_CHAR), dimension(:), allocatable, target :: farg1_chars class(TpetraMultiVector), intent(in) :: x - character(kind=C_CHAR, len=*), target :: matrixname character(kind=C_CHAR), dimension(:), allocatable, target :: farg3_chars character(kind=C_CHAR, len=*), target :: matrixdescription character(kind=C_CHAR), dimension(:), allocatable, target :: farg4_chars - type(SwigArrayWrapper) :: farg1 type(SwigClassWrapper) :: farg2 type(SwigArrayWrapper) :: farg3 @@ -11544,12 +10938,11 @@ subroutine TpetraWriter_writeDenseFile__SWIG_0(filename, x, matrixname, matrixde call swigc_TpetraWriter_writeDenseFile__SWIG_0(farg1, farg2, farg3, farg4) end subroutine -subroutine TpetraWriter_writeDenseFile__SWIG_1(filename, x) +subroutine swigf_TpetraWriter_writeDenseFile__SWIG_1(filename, x) use, intrinsic :: ISO_C_BINDING character(kind=C_CHAR, len=*), target :: filename character(kind=C_CHAR), dimension(:), allocatable, target :: farg1_chars class(TpetraMultiVector), intent(in) :: x - type(SwigArrayWrapper) :: farg1 type(SwigClassWrapper) :: farg2 @@ -11561,7 +10954,6 @@ subroutine TpetraWriter_writeDenseFile__SWIG_1(filename, x) subroutine delete_TpetraWriter(self) use, intrinsic :: ISO_C_BINDING class(TpetraWriter), intent(inout) :: self - type(SwigClassWrapper) :: farg1 farg1 = self%swigdata @@ -11572,27 +10964,31 @@ subroutine delete_TpetraWriter(self) self%swigdata%mem = SWIG_NULL end subroutine - subroutine swigf_assignment_TpetraWriter(self, other) - use, intrinsic :: ISO_C_BINDING - class(TpetraWriter), intent(inout) :: self - type(TpetraWriter), intent(in) :: other - call swigc_assignment_TpetraWriter(self%swigdata, other%swigdata) - end subroutine -subroutine TpetraMatrixMatrixMultiply__SWIG_0(a, transposea, b, transposeb, c, call_fillcomplete_on_result, label, params) +subroutine swigf_TpetraWriter_op_assign__(self, other) use, intrinsic :: ISO_C_BINDING -class(TpetraCrsMatrix), intent(in) :: a +class(TpetraWriter), intent(inout) :: self +type(SWIGTYPE_Tpetra__MatrixMarket__WriterT_Tpetra__CrsMatrixT_KG2R9), intent(in) :: other +type(SwigClassWrapper) :: farg1 +type(SwigClassWrapper) :: farg2 + +farg1 = self%swigdata +farg2 = other%swigdata +call swigc_TpetraWriter_op_assign__(farg1, farg2) +self%swigdata = farg1 +end subroutine +subroutine swigf_TpetraMatrixMatrixMultiply__SWIG_0(a, transposea, b, transposeb, c, call_fillcomplete_on_result, label, & + params) +use, intrinsic :: ISO_C_BINDING +class(TpetraCrsMatrix), intent(in) :: a logical, intent(in) :: transposea class(TpetraCrsMatrix), intent(in) :: b - logical, intent(in) :: transposeb -class(TpetraCrsMatrix), intent(inout) :: c - +class(TpetraCrsMatrix), intent(in) :: c logical, intent(in) :: call_fillcomplete_on_result character(kind=C_CHAR, len=*), target :: label character(kind=C_CHAR), dimension(:), allocatable, target :: farg7_chars class(ParameterList), intent(in) :: params - type(SwigClassWrapper) :: farg1 integer(C_INT) :: farg2 type(SwigClassWrapper) :: farg3 @@ -11613,20 +11009,16 @@ subroutine TpetraMatrixMatrixMultiply__SWIG_0(a, transposea, b, transposeb, c, c call swigc_TpetraMatrixMatrixMultiply__SWIG_0(farg1, farg2, farg3, farg4, farg5, farg6, farg7, farg8) end subroutine -subroutine TpetraMatrixMatrixMultiply__SWIG_1(a, transposea, b, transposeb, c, call_fillcomplete_on_result, label) +subroutine swigf_TpetraMatrixMatrixMultiply__SWIG_1(a, transposea, b, transposeb, c, call_fillcomplete_on_result, label) use, intrinsic :: ISO_C_BINDING class(TpetraCrsMatrix), intent(in) :: a - logical, intent(in) :: transposea class(TpetraCrsMatrix), intent(in) :: b - logical, intent(in) :: transposeb -class(TpetraCrsMatrix), intent(inout) :: c - +class(TpetraCrsMatrix), intent(in) :: c logical, intent(in) :: call_fillcomplete_on_result character(kind=C_CHAR, len=*), target :: label character(kind=C_CHAR), dimension(:), allocatable, target :: farg7_chars - type(SwigClassWrapper) :: farg1 integer(C_INT) :: farg2 type(SwigClassWrapper) :: farg3 @@ -11645,18 +11037,14 @@ subroutine TpetraMatrixMatrixMultiply__SWIG_1(a, transposea, b, transposeb, c, c call swigc_TpetraMatrixMatrixMultiply__SWIG_1(farg1, farg2, farg3, farg4, farg5, farg6, farg7) end subroutine -subroutine TpetraMatrixMatrixMultiply__SWIG_2(a, transposea, b, transposeb, c, call_fillcomplete_on_result) +subroutine swigf_TpetraMatrixMatrixMultiply__SWIG_2(a, transposea, b, transposeb, c, call_fillcomplete_on_result) use, intrinsic :: ISO_C_BINDING class(TpetraCrsMatrix), intent(in) :: a - logical, intent(in) :: transposea class(TpetraCrsMatrix), intent(in) :: b - logical, intent(in) :: transposeb -class(TpetraCrsMatrix), intent(inout) :: c - +class(TpetraCrsMatrix), intent(in) :: c logical, intent(in) :: call_fillcomplete_on_result - type(SwigClassWrapper) :: farg1 integer(C_INT) :: farg2 type(SwigClassWrapper) :: farg3 @@ -11673,16 +11061,13 @@ subroutine TpetraMatrixMatrixMultiply__SWIG_2(a, transposea, b, transposeb, c, c call swigc_TpetraMatrixMatrixMultiply__SWIG_2(farg1, farg2, farg3, farg4, farg5, farg6) end subroutine -subroutine TpetraMatrixMatrixMultiply__SWIG_3(a, transposea, b, transposeb, c) +subroutine swigf_TpetraMatrixMatrixMultiply__SWIG_3(a, transposea, b, transposeb, c) use, intrinsic :: ISO_C_BINDING class(TpetraCrsMatrix), intent(in) :: a - logical, intent(in) :: transposea class(TpetraCrsMatrix), intent(in) :: b - logical, intent(in) :: transposeb -class(TpetraCrsMatrix), intent(inout) :: c - +class(TpetraCrsMatrix), intent(in) :: c type(SwigClassWrapper) :: farg1 integer(C_INT) :: farg2 type(SwigClassWrapper) :: farg3 @@ -11697,16 +11082,13 @@ subroutine TpetraMatrixMatrixMultiply__SWIG_3(a, transposea, b, transposeb, c) call swigc_TpetraMatrixMatrixMultiply__SWIG_3(farg1, farg2, farg3, farg4, farg5) end subroutine -subroutine TpetraMatrixMatrixAdd__SWIG_0(a, transposea, scalara, b, scalarb) +subroutine swigf_TpetraMatrixMatrixAdd__SWIG_0(a, transposea, scalara, b, scalarb) use, intrinsic :: ISO_C_BINDING class(TpetraCrsMatrix), intent(in) :: a - logical, intent(in) :: transposea real(C_DOUBLE), intent(in) :: scalara -class(TpetraCrsMatrix), intent(inout) :: b - +class(TpetraCrsMatrix), intent(in) :: b real(C_DOUBLE), intent(in) :: scalarb - type(SwigClassWrapper) :: farg1 integer(C_INT) :: farg2 real(C_DOUBLE) :: farg3 @@ -11721,18 +11103,15 @@ subroutine TpetraMatrixMatrixAdd__SWIG_0(a, transposea, scalara, b, scalarb) call swigc_TpetraMatrixMatrixAdd__SWIG_0(farg1, farg2, farg3, farg4, farg5) end subroutine -subroutine TpetraMatrixMatrixAdd__SWIG_1(a, transposea, scalara, b, transposeb, scalarb, c) +subroutine swigf_TpetraMatrixMatrixAdd__SWIG_1(a, transposea, scalara, b, transposeb, scalarb, c) use, intrinsic :: ISO_C_BINDING class(TpetraCrsMatrix), intent(in) :: a - logical, intent(in) :: transposea real(C_DOUBLE), intent(in) :: scalara class(TpetraCrsMatrix), intent(in) :: b - logical, intent(in) :: transposeb real(C_DOUBLE), intent(in) :: scalarb -class(TpetraCrsMatrix), intent(inout) :: c - +class(TpetraCrsMatrix), intent(in) :: c type(SwigClassWrapper) :: farg1 integer(C_INT) :: farg2 real(C_DOUBLE) :: farg3 diff --git a/src/tpetra/src/swig/fortpetraFORTRAN_wrap.cxx b/src/tpetra/src/swig/fortpetraFORTRAN_wrap.cxx index c26bac53..a01f14d6 100644 --- a/src/tpetra/src/swig/fortpetraFORTRAN_wrap.cxx +++ b/src/tpetra/src/swig/fortpetraFORTRAN_wrap.cxx @@ -237,7 +237,7 @@ struct assignment_flags; #define SWIG_assign(LEFTTYPE, LEFT, RIGHTTYPE, RIGHT, FLAGS) \ - SWIG_assign_impl::value >(LEFT, RIGHT); + SWIG_assign_impl::value >(LEFT, RIGHT); #define SWIG_check_mutable(SWIG_CLASS_WRAPPER, TYPENAME, FNAME, FUNCNAME, RETURNNULL) \ @@ -486,7 +486,7 @@ struct AssignmentTraits { template -SWIGINTERN void SWIG_assign_impl(SwigClassWrapper* self, SwigClassWrapper* other) { +SWIGINTERN void SWIG_assign_impl(SwigClassWrapper* self, const SwigClassWrapper* other) { typedef swig::AssignmentTraits Traits_t; T1* pself = static_cast(self->cptr); T2* pother = static_cast(other->cptr); @@ -499,9 +499,7 @@ SWIGINTERN void SWIG_assign_impl(SwigClassWrapper* self, SwigClassWrapper* other break; case SWIG_MOVE: /* capture pointer from RHS */ self->cptr = other->cptr; - other->cptr = NULL; self->mem = SWIG_OWN; - other->mem = SWIG_NULL; break; case SWIG_OWN: /* copy from RHS */ self->cptr = Traits_t::copy_construct(pother); @@ -527,8 +525,6 @@ SWIGINTERN void SWIG_assign_impl(SwigClassWrapper* self, SwigClassWrapper* other /* Move RHS into LHS; delete RHS */ Traits_t::move_assign(pself, pother); Traits_t::destruct(pother); - other->cptr = NULL; - other->mem = SWIG_NULL; break; case SWIG_OWN: case SWIG_REF: @@ -556,8 +552,6 @@ SWIGINTERN void SWIG_assign_impl(SwigClassWrapper* self, SwigClassWrapper* other * same. */ Traits_t::move_assign(pself, pother); Traits_t::destruct(pother); - other->cptr = NULL; - other->mem = SWIG_NULL; break; case SWIG_OWN: case SWIG_REF: @@ -815,7 +809,6 @@ SWIGEXPORT void _wrap_setCombineModeParameter(SwigClassWrapper const *farg1, Swi SWIG_exception_impl("Tpetra::setCombineModeParameter(Teuchos::ParameterList &,std::string const &)", SWIG_UnknownError, "An unknown exception occurred", return ); } } - } @@ -1211,7 +1204,7 @@ SWIGEXPORT SwigClassWrapper _wrap_new_TpetraMap__SWIG_7() { } -SWIGEXPORT void _wrap_delete_TpetraMap(SwigClassWrapper const *farg1) { +SWIGEXPORT void _wrap_delete_TpetraMap(SwigClassWrapper *farg1) { Tpetra::Map< LO,GO,NO > *arg1 = (Tpetra::Map< LO,GO,NO > *) 0 ; Teuchos::RCP< Tpetra::Map< LO,GO,NO > > *smartarg1 ; @@ -1240,7 +1233,6 @@ SWIGEXPORT void _wrap_delete_TpetraMap(SwigClassWrapper const *farg1) { SWIG_exception_impl("Tpetra::Map< LO,GO,NO >::~Map()", SWIG_UnknownError, "An unknown exception occurred", return ); } } - } @@ -2283,11 +2275,38 @@ SWIGEXPORT SwigClassWrapper _wrap_TpetraMap_replaceCommWithSubset(SwigClassWrapp } -SWIGEXPORT void _wrap_assign_TpetraMap(SwigClassWrapper * self, SwigClassWrapper const * other) { - typedef Teuchos::RCP< Tpetra::Map > swig_lhs_classtype; - SWIG_assign(swig_lhs_classtype, self, - swig_lhs_classtype, const_cast(other), - 0 | swig::IS_DESTR | swig::IS_COPY_CONSTR); +SWIGEXPORT void _wrap_TpetraMap_op_assign__(SwigClassWrapper *farg1, SwigClassWrapper const *farg2) { + Tpetra::Map< LO,GO,NO > *arg1 = (Tpetra::Map< LO,GO,NO > *) 0 ; + Tpetra::Map< LO,GO,NO > *arg2 = 0 ; + Teuchos::RCP< Tpetra::Map< LO,GO,NO > > *smartarg1 ; + + smartarg1 = static_cast< Teuchos::RCP< Tpetra::Map >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::Map* >(smartarg1->get()) : NULL; + (void)sizeof(arg2); + { + // Make sure no unhandled exceptions exist before performing a new action + SWIG_check_unhandled_exception_impl("Tpetra::Map< LO,GO,NO >::operator =(Tpetra::Map< LO,GO,NO > const &)");; + try + { + // Attempt the wrapped function call + typedef Teuchos::RCP< Tpetra::Map > swig_lhs_classtype; + SWIG_assign(swig_lhs_classtype, farg1, swig_lhs_classtype, farg2, 0 | swig::IS_DESTR | swig::IS_COPY_CONSTR); + } + catch (const std::range_error& e) + { + // Store a C++ exception + SWIG_exception_impl("Tpetra::Map< LO,GO,NO >::operator =(Tpetra::Map< LO,GO,NO > const &)", SWIG_IndexError, e.what(), return ); + } + catch (const std::exception& e) + { + // Store a C++ exception + SWIG_exception_impl("Tpetra::Map< LO,GO,NO >::operator =(Tpetra::Map< LO,GO,NO > const &)", SWIG_RuntimeError, e.what(), return ); + } + catch (...) + { + SWIG_exception_impl("Tpetra::Map< LO,GO,NO >::operator =(Tpetra::Map< LO,GO,NO > const &)", SWIG_UnknownError, "An unknown exception occurred", return ); + } + } } @@ -2448,7 +2467,7 @@ SWIGEXPORT SwigClassWrapper _wrap_new_TpetraImport__SWIG_3(SwigClassWrapper cons } -SWIGEXPORT void _wrap_delete_TpetraImport(SwigClassWrapper const *farg1) { +SWIGEXPORT void _wrap_delete_TpetraImport(SwigClassWrapper *farg1) { Tpetra::Import< LO,GO,NO > *arg1 = (Tpetra::Import< LO,GO,NO > *) 0 ; Teuchos::RCP< Tpetra::Import< LO,GO,NO > > *smartarg1 ; @@ -2477,7 +2496,6 @@ SWIGEXPORT void _wrap_delete_TpetraImport(SwigClassWrapper const *farg1) { SWIG_exception_impl("Tpetra::Import< LO,GO,NO >::~Import()", SWIG_UnknownError, "An unknown exception occurred", return ); } } - } @@ -2513,7 +2531,6 @@ SWIGEXPORT void _wrap_TpetraImport_setParameterList(SwigClassWrapper const *farg SWIG_exception_impl("Tpetra::Import< LO,GO,NO >::setParameterList(Teuchos::RCP< Teuchos::ParameterList > const &)", SWIG_UnknownError, "An unknown exception occurred", return ); } } - } @@ -2922,15 +2939,41 @@ SWIGEXPORT void _wrap_TpetraImport_print(SwigClassWrapper const *farg1, SwigClas SWIG_exception_impl("Tpetra::Import< LO,GO,NO >::print(std::ostream &) const", SWIG_UnknownError, "An unknown exception occurred", return ); } } - } -SWIGEXPORT void _wrap_assign_TpetraImport(SwigClassWrapper * self, SwigClassWrapper const * other) { - typedef Teuchos::RCP< Tpetra::Import > swig_lhs_classtype; - SWIG_assign(swig_lhs_classtype, self, - swig_lhs_classtype, const_cast(other), - 0 | swig::IS_DESTR | swig::IS_COPY_CONSTR | swig::IS_COPY_ASSIGN); +SWIGEXPORT void _wrap_TpetraImport_op_assign__(SwigClassWrapper *farg1, SwigClassWrapper const *farg2) { + Tpetra::Import< LO,GO,NO > *arg1 = (Tpetra::Import< LO,GO,NO > *) 0 ; + Tpetra::Import< LO,GO,NO > *arg2 = 0 ; + Teuchos::RCP< Tpetra::Import< LO,GO,NO > > *smartarg1 ; + + smartarg1 = static_cast< Teuchos::RCP< Tpetra::Import >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::Import* >(smartarg1->get()) : NULL; + (void)sizeof(arg2); + { + // Make sure no unhandled exceptions exist before performing a new action + SWIG_check_unhandled_exception_impl("Tpetra::Import< LO,GO,NO >::operator =(Tpetra::Import< LO,GO,NO > const &)");; + try + { + // Attempt the wrapped function call + typedef Teuchos::RCP< Tpetra::Import > swig_lhs_classtype; + SWIG_assign(swig_lhs_classtype, farg1, swig_lhs_classtype, farg2, 0 | swig::IS_DESTR | swig::IS_COPY_CONSTR | swig::IS_COPY_ASSIGN); + } + catch (const std::range_error& e) + { + // Store a C++ exception + SWIG_exception_impl("Tpetra::Import< LO,GO,NO >::operator =(Tpetra::Import< LO,GO,NO > const &)", SWIG_IndexError, e.what(), return ); + } + catch (const std::exception& e) + { + // Store a C++ exception + SWIG_exception_impl("Tpetra::Import< LO,GO,NO >::operator =(Tpetra::Import< LO,GO,NO > const &)", SWIG_RuntimeError, e.what(), return ); + } + catch (...) + { + SWIG_exception_impl("Tpetra::Import< LO,GO,NO >::operator =(Tpetra::Import< LO,GO,NO > const &)", SWIG_UnknownError, "An unknown exception occurred", return ); + } + } } @@ -3091,7 +3134,7 @@ SWIGEXPORT SwigClassWrapper _wrap_new_TpetraExport__SWIG_3(SwigClassWrapper cons } -SWIGEXPORT void _wrap_delete_TpetraExport(SwigClassWrapper const *farg1) { +SWIGEXPORT void _wrap_delete_TpetraExport(SwigClassWrapper *farg1) { Tpetra::Export< LO,GO,NO > *arg1 = (Tpetra::Export< LO,GO,NO > *) 0 ; Teuchos::RCP< Tpetra::Export< LO,GO,NO > > *smartarg1 ; @@ -3120,7 +3163,6 @@ SWIGEXPORT void _wrap_delete_TpetraExport(SwigClassWrapper const *farg1) { SWIG_exception_impl("Tpetra::Export< LO,GO,NO >::~Export()", SWIG_UnknownError, "An unknown exception occurred", return ); } } - } @@ -3156,7 +3198,6 @@ SWIGEXPORT void _wrap_TpetraExport_setParameterList(SwigClassWrapper const *farg SWIG_exception_impl("Tpetra::Export< LO,GO,NO >::setParameterList(Teuchos::RCP< Teuchos::ParameterList > const &)", SWIG_UnknownError, "An unknown exception occurred", return ); } } - } @@ -3446,15 +3487,41 @@ SWIGEXPORT void _wrap_TpetraExport_print(SwigClassWrapper const *farg1, SwigClas SWIG_exception_impl("Tpetra::Export< LO,GO,NO >::print(std::ostream &) const", SWIG_UnknownError, "An unknown exception occurred", return ); } } - } -SWIGEXPORT void _wrap_assign_TpetraExport(SwigClassWrapper * self, SwigClassWrapper const * other) { - typedef Teuchos::RCP< Tpetra::Export > swig_lhs_classtype; - SWIG_assign(swig_lhs_classtype, self, - swig_lhs_classtype, const_cast(other), - 0 | swig::IS_DESTR | swig::IS_COPY_CONSTR | swig::IS_COPY_ASSIGN); +SWIGEXPORT void _wrap_TpetraExport_op_assign__(SwigClassWrapper *farg1, SwigClassWrapper const *farg2) { + Tpetra::Export< LO,GO,NO > *arg1 = (Tpetra::Export< LO,GO,NO > *) 0 ; + Tpetra::Export< LO,GO,NO > *arg2 = 0 ; + Teuchos::RCP< Tpetra::Export< LO,GO,NO > > *smartarg1 ; + + smartarg1 = static_cast< Teuchos::RCP< Tpetra::Export >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::Export* >(smartarg1->get()) : NULL; + (void)sizeof(arg2); + { + // Make sure no unhandled exceptions exist before performing a new action + SWIG_check_unhandled_exception_impl("Tpetra::Export< LO,GO,NO >::operator =(Tpetra::Export< LO,GO,NO > const &)");; + try + { + // Attempt the wrapped function call + typedef Teuchos::RCP< Tpetra::Export > swig_lhs_classtype; + SWIG_assign(swig_lhs_classtype, farg1, swig_lhs_classtype, farg2, 0 | swig::IS_DESTR | swig::IS_COPY_CONSTR | swig::IS_COPY_ASSIGN); + } + catch (const std::range_error& e) + { + // Store a C++ exception + SWIG_exception_impl("Tpetra::Export< LO,GO,NO >::operator =(Tpetra::Export< LO,GO,NO > const &)", SWIG_IndexError, e.what(), return ); + } + catch (const std::exception& e) + { + // Store a C++ exception + SWIG_exception_impl("Tpetra::Export< LO,GO,NO >::operator =(Tpetra::Export< LO,GO,NO > const &)", SWIG_RuntimeError, e.what(), return ); + } + catch (...) + { + SWIG_exception_impl("Tpetra::Export< LO,GO,NO >::operator =(Tpetra::Export< LO,GO,NO > const &)", SWIG_UnknownError, "An unknown exception occurred", return ); + } + } } @@ -3813,11 +3880,10 @@ SWIGEXPORT void _wrap_TpetraMultiVector_swap(SwigClassWrapper const *farg1, Swig SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::swap(Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > &)", SWIG_UnknownError, "An unknown exception occurred", return ); } } - } -SWIGEXPORT void _wrap_delete_TpetraMultiVector(SwigClassWrapper const *farg1) { +SWIGEXPORT void _wrap_delete_TpetraMultiVector(SwigClassWrapper *farg1) { Tpetra::MultiVector< SC,LO,GO,NO > *arg1 = (Tpetra::MultiVector< SC,LO,GO,NO > *) 0 ; Teuchos::RCP< Tpetra::MultiVector< SC,LO,GO,NO > > *smartarg1 ; @@ -3846,7 +3912,6 @@ SWIGEXPORT void _wrap_delete_TpetraMultiVector(SwigClassWrapper const *farg1) { SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::~MultiVector()", SWIG_UnknownError, "An unknown exception occurred", return ); } } - } @@ -3887,7 +3952,6 @@ SWIGEXPORT void _wrap_TpetraMultiVector_replaceGlobalValue(SwigClassWrapper cons SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::replaceGlobalValue(long long const,size_t const,Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::impl_scalar_type const &) const", SWIG_UnknownError, "An unknown exception occurred", return ); } } - } @@ -3930,7 +3994,6 @@ SWIGEXPORT void _wrap_TpetraMultiVector_sumIntoGlobalValue__SWIG_0(SwigClassWrap SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::sumIntoGlobalValue(long long const,size_t const,Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::impl_scalar_type const &,bool const) const", SWIG_UnknownError, "An unknown exception occurred", return ); } } - } @@ -3971,7 +4034,6 @@ SWIGEXPORT void _wrap_TpetraMultiVector_sumIntoGlobalValue__SWIG_1(SwigClassWrap SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::sumIntoGlobalValue(long long const,size_t const,Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::impl_scalar_type const &) const", SWIG_UnknownError, "An unknown exception occurred", return ); } } - } @@ -4012,7 +4074,6 @@ SWIGEXPORT void _wrap_TpetraMultiVector_replaceLocalValue(SwigClassWrapper const SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::replaceLocalValue(int const,size_t const,Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::impl_scalar_type const &) const", SWIG_UnknownError, "An unknown exception occurred", return ); } } - } @@ -4055,7 +4116,6 @@ SWIGEXPORT void _wrap_TpetraMultiVector_sumIntoLocalValue__SWIG_0(SwigClassWrapp SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::sumIntoLocalValue(int const,size_t const,Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::impl_scalar_type const &,bool const) const", SWIG_UnknownError, "An unknown exception occurred", return ); } } - } @@ -4096,7 +4156,6 @@ SWIGEXPORT void _wrap_TpetraMultiVector_sumIntoLocalValue__SWIG_1(SwigClassWrapp SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::sumIntoLocalValue(int const,size_t const,Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::impl_scalar_type const &) const", SWIG_UnknownError, "An unknown exception occurred", return ); } } - } @@ -4133,7 +4192,6 @@ SWIGEXPORT void _wrap_TpetraMultiVector_putScalar(SwigClassWrapper const *farg1, SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::putScalar(double const &)", SWIG_UnknownError, "An unknown exception occurred", return ); } } - } @@ -4166,7 +4224,6 @@ SWIGEXPORT void _wrap_TpetraMultiVector_randomize__SWIG_0(SwigClassWrapper const SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::randomize()", SWIG_UnknownError, "An unknown exception occurred", return ); } } - } @@ -4207,7 +4264,6 @@ SWIGEXPORT void _wrap_TpetraMultiVector_randomize__SWIG_1(SwigClassWrapper const SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::randomize(double const &,double const &)", SWIG_UnknownError, "An unknown exception occurred", return ); } } - } @@ -4243,7 +4299,6 @@ SWIGEXPORT void _wrap_TpetraMultiVector_replaceMap(SwigClassWrapper const *farg1 SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::replaceMap(Teuchos::RCP< Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &)", SWIG_UnknownError, "An unknown exception occurred", return ); } } - } @@ -4276,7 +4331,6 @@ SWIGEXPORT void _wrap_TpetraMultiVector_reduce(SwigClassWrapper const *farg1) { SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::reduce()", SWIG_UnknownError, "An unknown exception occurred", return ); } } - } @@ -4618,7 +4672,6 @@ SWIGEXPORT void _wrap_TpetraMultiVector_get1dCopy(SwigClassWrapper const *farg1, SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::get1dCopy(Teuchos::ArrayView< double > const &,size_t const) const", SWIG_UnknownError, "An unknown exception occurred", return ); } } - } @@ -4725,7 +4778,6 @@ SWIGEXPORT void _wrap_TpetraMultiVector_sync_host(SwigClassWrapper const *farg1) SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::sync_host()", SWIG_UnknownError, "An unknown exception occurred", return ); } } - } @@ -4758,7 +4810,6 @@ SWIGEXPORT void _wrap_TpetraMultiVector_sync_device(SwigClassWrapper const *farg SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::sync_device()", SWIG_UnknownError, "An unknown exception occurred", return ); } } - } @@ -4863,7 +4914,6 @@ SWIGEXPORT void _wrap_TpetraMultiVector_modify_device(SwigClassWrapper const *fa SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::modify_device()", SWIG_UnknownError, "An unknown exception occurred", return ); } } - } @@ -4896,7 +4946,6 @@ SWIGEXPORT void _wrap_TpetraMultiVector_modify_host(SwigClassWrapper const *farg SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::modify_host()", SWIG_UnknownError, "An unknown exception occurred", return ); } } - } @@ -4938,7 +4987,6 @@ SWIGEXPORT void _wrap_TpetraMultiVector_dot__SWIG_0(SwigClassWrapper const *farg SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::dot(Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &,Teuchos::ArrayView< Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::dot_type > const &) const", SWIG_UnknownError, "An unknown exception occurred", return ); } } - } @@ -4979,7 +5027,6 @@ SWIGEXPORT void _wrap_TpetraMultiVector_dot__SWIG_3(SwigClassWrapper const *farg SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::dot(Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &,Kokkos::View< Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::dot_type *,Kokkos::HostSpace > const &) const", SWIG_UnknownError, "An unknown exception occurred", return ); } } - } @@ -5017,7 +5064,6 @@ SWIGEXPORT void _wrap_TpetraMultiVector_abs(SwigClassWrapper const *farg1, SwigC SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::abs(Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &)", SWIG_UnknownError, "An unknown exception occurred", return ); } } - } @@ -5055,7 +5101,6 @@ SWIGEXPORT void _wrap_TpetraMultiVector_reciprocal(SwigClassWrapper const *farg1 SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::reciprocal(Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &)", SWIG_UnknownError, "An unknown exception occurred", return ); } } - } @@ -5092,7 +5137,6 @@ SWIGEXPORT void _wrap_TpetraMultiVector_scale__SWIG_0(SwigClassWrapper const *fa SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::scale(double const &)", SWIG_UnknownError, "An unknown exception occurred", return ); } } - } @@ -5129,7 +5173,6 @@ SWIGEXPORT void _wrap_TpetraMultiVector_scale__SWIG_1(SwigClassWrapper const *fa SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::scale(Teuchos::ArrayView< double const > const &)", SWIG_UnknownError, "An unknown exception occurred", return ); } } - } @@ -5171,7 +5214,6 @@ SWIGEXPORT void _wrap_TpetraMultiVector_scale__SWIG_2(SwigClassWrapper const *fa SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::scale(double const &,Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &)", SWIG_UnknownError, "An unknown exception occurred", return ); } } - } @@ -5217,7 +5259,6 @@ SWIGEXPORT void _wrap_TpetraMultiVector_update__SWIG_0(SwigClassWrapper const *f SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::update(double const &,Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &,double const &)", SWIG_UnknownError, "An unknown exception occurred", return ); } } - } @@ -5272,7 +5313,6 @@ SWIGEXPORT void _wrap_TpetraMultiVector_update__SWIG_1(SwigClassWrapper const *f SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::update(double const &,Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &,double const &,Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &,double const &)", SWIG_UnknownError, "An unknown exception occurred", return ); } } - } @@ -5308,7 +5348,6 @@ SWIGEXPORT void _wrap_TpetraMultiVector_norm1__SWIG_1(SwigClassWrapper const *fa SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::norm1(Kokkos::View< Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::mag_type *,Kokkos::HostSpace > const &) const", SWIG_UnknownError, "An unknown exception occurred", return ); } } - } @@ -5345,7 +5384,6 @@ SWIGEXPORT void _wrap_TpetraMultiVector_norm1__SWIG_3(SwigClassWrapper const *fa SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::norm1(Teuchos::ArrayView< Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::mag_type > const &) const", SWIG_UnknownError, "An unknown exception occurred", return ); } } - } @@ -5381,7 +5419,6 @@ SWIGEXPORT void _wrap_TpetraMultiVector_norm2__SWIG_1(SwigClassWrapper const *fa SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::norm2(Kokkos::View< Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::mag_type *,Kokkos::HostSpace > const &) const", SWIG_UnknownError, "An unknown exception occurred", return ); } } - } @@ -5418,7 +5455,6 @@ SWIGEXPORT void _wrap_TpetraMultiVector_norm2__SWIG_3(SwigClassWrapper const *fa SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::norm2(Teuchos::ArrayView< Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::mag_type > const &) const", SWIG_UnknownError, "An unknown exception occurred", return ); } } - } @@ -5454,7 +5490,6 @@ SWIGEXPORT void _wrap_TpetraMultiVector_normInf__SWIG_1(SwigClassWrapper const * SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::normInf(Kokkos::View< Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::mag_type *,Kokkos::HostSpace > const &) const", SWIG_UnknownError, "An unknown exception occurred", return ); } } - } @@ -5491,7 +5526,6 @@ SWIGEXPORT void _wrap_TpetraMultiVector_normInf__SWIG_3(SwigClassWrapper const * SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::normInf(Teuchos::ArrayView< Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::mag_type > const &) const", SWIG_UnknownError, "An unknown exception occurred", return ); } } - } @@ -5528,7 +5562,6 @@ SWIGEXPORT void _wrap_TpetraMultiVector_meanValue(SwigClassWrapper const *farg1, SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::meanValue(Teuchos::ArrayView< Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::impl_scalar_type > const &) const", SWIG_UnknownError, "An unknown exception occurred", return ); } } - } @@ -5583,7 +5616,6 @@ SWIGEXPORT void _wrap_TpetraMultiVector_multiply(SwigClassWrapper const *farg1, SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::multiply(Teuchos::ETransp,Teuchos::ETransp,double const &,Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &,Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &,double const &)", SWIG_UnknownError, "An unknown exception occurred", return ); } } - } @@ -5841,7 +5873,6 @@ SWIGEXPORT void _wrap_TpetraMultiVector_removeEmptyProcessesInPlace(SwigClassWra SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::removeEmptyProcessesInPlace(Teuchos::RCP< Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &)", SWIG_UnknownError, "An unknown exception occurred", return ); } } - } @@ -5876,7 +5907,6 @@ SWIGEXPORT void _wrap_TpetraMultiVector_setCopyOrView(SwigClassWrapper const *fa SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::setCopyOrView(Teuchos::DataAccess const)", SWIG_UnknownError, "An unknown exception occurred", return ); } } - } @@ -5998,7 +6028,6 @@ SWIGEXPORT void _wrap_TpetraMultiVector_doImport__SWIG_0(SwigClassWrapper const SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::doImport(Tpetra::MultiVector< SC,LO,GO,NO > const &,Tpetra::Import< LO,GO,NO > const &,Tpetra::CombineMode)", SWIG_UnknownError, "An unknown exception occurred", return ); } } - } @@ -6043,7 +6072,6 @@ SWIGEXPORT void _wrap_TpetraMultiVector_doImport__SWIG_1(SwigClassWrapper const SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::doImport(Tpetra::MultiVector< SC,LO,GO,NO > const &,Tpetra::Export< LO,GO,NO > const &,Tpetra::CombineMode)", SWIG_UnknownError, "An unknown exception occurred", return ); } } - } @@ -6088,7 +6116,6 @@ SWIGEXPORT void _wrap_TpetraMultiVector_doExport__SWIG_0(SwigClassWrapper const SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::doExport(Tpetra::MultiVector< SC,LO,GO,NO > const &,Tpetra::Export< LO,GO,NO > const &,Tpetra::CombineMode)", SWIG_UnknownError, "An unknown exception occurred", return ); } } - } @@ -6133,19 +6160,45 @@ SWIGEXPORT void _wrap_TpetraMultiVector_doExport__SWIG_1(SwigClassWrapper const SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::doExport(Tpetra::MultiVector< SC,LO,GO,NO > const &,Tpetra::Import< LO,GO,NO > const &,Tpetra::CombineMode)", SWIG_UnknownError, "An unknown exception occurred", return ); } } - } -SWIGEXPORT void _wrap_assign_TpetraMultiVector(SwigClassWrapper * self, SwigClassWrapper const * other) { - typedef Teuchos::RCP< Tpetra::MultiVector > swig_lhs_classtype; - SWIG_assign(swig_lhs_classtype, self, - swig_lhs_classtype, const_cast(other), - 0 | swig::IS_DESTR | swig::IS_COPY_CONSTR | swig::IS_COPY_ASSIGN); +SWIGEXPORT void _wrap_TpetraMultiVector_op_assign__(SwigClassWrapper *farg1, SwigClassWrapper const *farg2) { + Tpetra::MultiVector< SC,LO,GO,NO > *arg1 = (Tpetra::MultiVector< SC,LO,GO,NO > *) 0 ; + Tpetra::MultiVector< SC,LO,GO,NO > *arg2 = 0 ; + Teuchos::RCP< Tpetra::MultiVector< SC,LO,GO,NO > > *smartarg1 ; + + smartarg1 = static_cast< Teuchos::RCP< Tpetra::MultiVector >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::MultiVector* >(smartarg1->get()) : NULL; + (void)sizeof(arg2); + { + // Make sure no unhandled exceptions exist before performing a new action + SWIG_check_unhandled_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::operator =(Tpetra::MultiVector< SC,LO,GO,NO > const &)");; + try + { + // Attempt the wrapped function call + typedef Teuchos::RCP< Tpetra::MultiVector > swig_lhs_classtype; + SWIG_assign(swig_lhs_classtype, farg1, swig_lhs_classtype, farg2, 0 | swig::IS_DESTR | swig::IS_COPY_CONSTR | swig::IS_COPY_ASSIGN); + } + catch (const std::range_error& e) + { + // Store a C++ exception + SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::operator =(Tpetra::MultiVector< SC,LO,GO,NO > const &)", SWIG_IndexError, e.what(), return ); + } + catch (const std::exception& e) + { + // Store a C++ exception + SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::operator =(Tpetra::MultiVector< SC,LO,GO,NO > const &)", SWIG_RuntimeError, e.what(), return ); + } + catch (...) + { + SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::operator =(Tpetra::MultiVector< SC,LO,GO,NO > const &)", SWIG_UnknownError, "An unknown exception occurred", return ); + } + } } -SWIGEXPORT void _wrap_delete_TpetraOperator(SwigClassWrapper const *farg1) { +SWIGEXPORT void _wrap_delete_TpetraOperator(SwigClassWrapper *farg1) { Tpetra::Operator< SC,LO,GO,NO > *arg1 = (Tpetra::Operator< SC,LO,GO,NO > *) 0 ; Teuchos::RCP< Tpetra::Operator< SC,LO,GO,NO > > *smartarg1 ; @@ -6174,15 +6227,41 @@ SWIGEXPORT void _wrap_delete_TpetraOperator(SwigClassWrapper const *farg1) { SWIG_exception_impl("Tpetra::Operator< SC,LO,GO,NO >::~Operator()", SWIG_UnknownError, "An unknown exception occurred", return ); } } - } -SWIGEXPORT void _wrap_assign_TpetraOperator(SwigClassWrapper * self, SwigClassWrapper const * other) { - typedef Teuchos::RCP< Tpetra::Operator > swig_lhs_classtype; - SWIG_assign(swig_lhs_classtype, self, - swig_lhs_classtype, const_cast(other), - 0 | swig::IS_DESTR | swig::IS_COPY_CONSTR); +SWIGEXPORT void _wrap_TpetraOperator_op_assign__(SwigClassWrapper *farg1, SwigClassWrapper const *farg2) { + Tpetra::Operator< SC,LO,GO,NO > *arg1 = (Tpetra::Operator< SC,LO,GO,NO > *) 0 ; + Tpetra::Operator< SC,LO,GO,NO > *arg2 = 0 ; + Teuchos::RCP< Tpetra::Operator< SC,LO,GO,NO > > *smartarg1 ; + + smartarg1 = static_cast< Teuchos::RCP< Tpetra::Operator >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::Operator* >(smartarg1->get()) : NULL; + (void)sizeof(arg2); + { + // Make sure no unhandled exceptions exist before performing a new action + SWIG_check_unhandled_exception_impl("Tpetra::Operator< SC,LO,GO,NO >::operator =(Tpetra::Operator< SC,LO,GO,NO > const &)");; + try + { + // Attempt the wrapped function call + typedef Teuchos::RCP< Tpetra::Operator > swig_lhs_classtype; + SWIG_assign(swig_lhs_classtype, farg1, swig_lhs_classtype, farg2, 0 | swig::IS_DESTR | swig::IS_COPY_CONSTR); + } + catch (const std::range_error& e) + { + // Store a C++ exception + SWIG_exception_impl("Tpetra::Operator< SC,LO,GO,NO >::operator =(Tpetra::Operator< SC,LO,GO,NO > const &)", SWIG_IndexError, e.what(), return ); + } + catch (const std::exception& e) + { + // Store a C++ exception + SWIG_exception_impl("Tpetra::Operator< SC,LO,GO,NO >::operator =(Tpetra::Operator< SC,LO,GO,NO > const &)", SWIG_RuntimeError, e.what(), return ); + } + catch (...) + { + SWIG_exception_impl("Tpetra::Operator< SC,LO,GO,NO >::operator =(Tpetra::Operator< SC,LO,GO,NO > const &)", SWIG_UnknownError, "An unknown exception occurred", return ); + } + } } @@ -6253,7 +6332,6 @@ SWIGEXPORT void _wrap_ForTpetraOperator_init(SwigClassWrapper const *farg1, void SWIG_exception_impl("ForTpetraOperator::init(void *)", SWIG_UnknownError, "An unknown exception occurred", return ); } } - } @@ -6409,11 +6487,10 @@ SWIGEXPORT void _wrap_ForTpetraOperator_apply(SwigClassWrapper const *farg1, Swi SWIG_exception_impl("ForTpetraOperator::apply(ForTpetraOperator::vector_type const &,ForTpetraOperator::vector_type &,Teuchos::ETransp,SC,SC) const", SWIG_UnknownError, "An unknown exception occurred", return ); } } - } -SWIGEXPORT void _wrap_delete_ForTpetraOperator(SwigClassWrapper const *farg1) { +SWIGEXPORT void _wrap_delete_ForTpetraOperator(SwigClassWrapper *farg1) { ForTpetraOperator *arg1 = (ForTpetraOperator *) 0 ; Teuchos::RCP< ForTpetraOperator > *smartarg1 ; @@ -6442,15 +6519,44 @@ SWIGEXPORT void _wrap_delete_ForTpetraOperator(SwigClassWrapper const *farg1) { SWIG_exception_impl("ForTpetraOperator::~ForTpetraOperator()", SWIG_UnknownError, "An unknown exception occurred", return ); } } - } -SWIGEXPORT void _wrap_assign_ForTpetraOperator(SwigClassWrapper * self, SwigClassWrapper const * other) { - typedef Teuchos::RCP< ForTpetraOperator > swig_lhs_classtype; - SWIG_assign(swig_lhs_classtype, self, - swig_lhs_classtype, const_cast(other), - 0 | swig::IS_DESTR | swig::IS_COPY_CONSTR); +SWIGEXPORT void _wrap_ForTpetraOperator_op_assign__(SwigClassWrapper *farg1, SwigClassWrapper const *farg2) { + ForTpetraOperator *arg1 = (ForTpetraOperator *) 0 ; + ForTpetraOperator *arg2 = 0 ; + Teuchos::RCP< ForTpetraOperator > *smartarg1 ; + Teuchos::RCP< ForTpetraOperator const > *smartarg2 ; + + smartarg1 = static_cast< Teuchos::RCP< ForTpetraOperator >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< ForTpetraOperator* >(smartarg1->get()) : NULL; + SWIG_check_sp_nonnull(farg2, "ForTpetraOperator *", "ForTpetraOperator", "ForTpetraOperator::operator =(ForTpetraOperator const &)", return ) + smartarg2 = static_cast< Teuchos::RCP* >(farg2->cptr); + arg2 = const_cast< ForTpetraOperator* >(smartarg2->get()); + { + // Make sure no unhandled exceptions exist before performing a new action + SWIG_check_unhandled_exception_impl("ForTpetraOperator::operator =(ForTpetraOperator const &)");; + try + { + // Attempt the wrapped function call + typedef Teuchos::RCP< ForTpetraOperator > swig_lhs_classtype; + SWIG_assign(swig_lhs_classtype, farg1, swig_lhs_classtype, farg2, 0 | swig::IS_DESTR | swig::IS_COPY_CONSTR); + } + catch (const std::range_error& e) + { + // Store a C++ exception + SWIG_exception_impl("ForTpetraOperator::operator =(ForTpetraOperator const &)", SWIG_IndexError, e.what(), return ); + } + catch (const std::exception& e) + { + // Store a C++ exception + SWIG_exception_impl("ForTpetraOperator::operator =(ForTpetraOperator const &)", SWIG_RuntimeError, e.what(), return ); + } + catch (...) + { + SWIG_exception_impl("ForTpetraOperator::operator =(ForTpetraOperator const &)", SWIG_UnknownError, "An unknown exception occurred", return ); + } + } } @@ -6462,7 +6568,6 @@ SWIGEXPORT void _wrap_RowInfo_localRow_set(SwigClassWrapper const *farg1, size_t arg1 = static_cast< Tpetra::RowInfo * >(farg1->cptr); arg2 = static_cast< size_t >(*farg2); if (arg1) (arg1)->localRow = arg2; - } @@ -6487,7 +6592,6 @@ SWIGEXPORT void _wrap_RowInfo_allocSize_set(SwigClassWrapper const *farg1, size_ arg1 = static_cast< Tpetra::RowInfo * >(farg1->cptr); arg2 = static_cast< size_t >(*farg2); if (arg1) (arg1)->allocSize = arg2; - } @@ -6512,7 +6616,6 @@ SWIGEXPORT void _wrap_RowInfo_numEntries_set(SwigClassWrapper const *farg1, size arg1 = static_cast< Tpetra::RowInfo * >(farg1->cptr); arg2 = static_cast< size_t >(*farg2); if (arg1) (arg1)->numEntries = arg2; - } @@ -6537,7 +6640,6 @@ SWIGEXPORT void _wrap_RowInfo_offset1D_set(SwigClassWrapper const *farg1, size_t arg1 = static_cast< Tpetra::RowInfo * >(farg1->cptr); arg2 = static_cast< size_t >(*farg2); if (arg1) (arg1)->offset1D = arg2; - } @@ -6587,11 +6689,10 @@ SWIGEXPORT SwigClassWrapper _wrap_new_RowInfo() { } -SWIGEXPORT void _wrap_delete_RowInfo(SwigClassWrapper const *farg1) { +SWIGEXPORT void _wrap_delete_RowInfo(SwigClassWrapper *farg1) { Tpetra::RowInfo *arg1 = (Tpetra::RowInfo *) 0 ; - SWIG_check_mutable_nonnull(*farg1, "Tpetra::RowInfo *", "RowInfo", "Tpetra::RowInfo::~RowInfo()", return ); - arg1 = static_cast< Tpetra::RowInfo * >(farg1->cptr); + (void)sizeof(farg1); { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::RowInfo::~RowInfo()");; @@ -6615,15 +6716,39 @@ SWIGEXPORT void _wrap_delete_RowInfo(SwigClassWrapper const *farg1) { SWIG_exception_impl("Tpetra::RowInfo::~RowInfo()", SWIG_UnknownError, "An unknown exception occurred", return ); } } - } -SWIGEXPORT void _wrap_assign_RowInfo(SwigClassWrapper * self, SwigClassWrapper const * other) { - typedef Tpetra::RowInfo swig_lhs_classtype; - SWIG_assign(swig_lhs_classtype, self, - swig_lhs_classtype, const_cast(other), - 0 | swig::IS_DESTR | swig::IS_COPY_CONSTR); +SWIGEXPORT void _wrap_RowInfo_op_assign__(SwigClassWrapper *farg1, SwigClassWrapper const *farg2) { + Tpetra::RowInfo *arg1 = (Tpetra::RowInfo *) 0 ; + Tpetra::RowInfo *arg2 = 0 ; + + (void)sizeof(arg1); + (void)sizeof(arg2); + { + // Make sure no unhandled exceptions exist before performing a new action + SWIG_check_unhandled_exception_impl("Tpetra::RowInfo::operator =(Tpetra::RowInfo const &)");; + try + { + // Attempt the wrapped function call + typedef Tpetra::RowInfo swig_lhs_classtype; + SWIG_assign(swig_lhs_classtype, farg1, swig_lhs_classtype, farg2, 0 | swig::IS_DESTR | swig::IS_COPY_CONSTR); + } + catch (const std::range_error& e) + { + // Store a C++ exception + SWIG_exception_impl("Tpetra::RowInfo::operator =(Tpetra::RowInfo const &)", SWIG_IndexError, e.what(), return ); + } + catch (const std::exception& e) + { + // Store a C++ exception + SWIG_exception_impl("Tpetra::RowInfo::operator =(Tpetra::RowInfo const &)", SWIG_RuntimeError, e.what(), return ); + } + catch (...) + { + SWIG_exception_impl("Tpetra::RowInfo::operator =(Tpetra::RowInfo const &)", SWIG_UnknownError, "An unknown exception occurred", return ); + } + } } @@ -7262,7 +7387,7 @@ SWIGEXPORT SwigClassWrapper _wrap_new_TpetraCrsGraph__SWIG_13(SwigClassWrapper c } -SWIGEXPORT void _wrap_delete_TpetraCrsGraph(SwigClassWrapper const *farg1) { +SWIGEXPORT void _wrap_delete_TpetraCrsGraph(SwigClassWrapper *farg1) { Tpetra::CrsGraph< LO,GO,NO > *arg1 = (Tpetra::CrsGraph< LO,GO,NO > *) 0 ; Teuchos::RCP< Tpetra::CrsGraph< LO,GO,NO > > *smartarg1 ; @@ -7291,7 +7416,6 @@ SWIGEXPORT void _wrap_delete_TpetraCrsGraph(SwigClassWrapper const *farg1) { SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::~CrsGraph()", SWIG_UnknownError, "An unknown exception occurred", return ); } } - } @@ -7329,7 +7453,6 @@ SWIGEXPORT void _wrap_TpetraCrsGraph_swap(SwigClassWrapper const *farg1, SwigCla SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::swap(Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode > &)", SWIG_UnknownError, "An unknown exception occurred", return ); } } - } @@ -7406,7 +7529,6 @@ SWIGEXPORT void _wrap_TpetraCrsGraph_setParameterList(SwigClassWrapper const *fa SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::setParameterList(Teuchos::RCP< Teuchos::ParameterList > const &)", SWIG_UnknownError, "An unknown exception occurred", return ); } } - } @@ -7482,7 +7604,6 @@ SWIGEXPORT void _wrap_TpetraCrsGraph_insertGlobalIndices__SWIG_0(SwigClassWrappe SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::insertGlobalIndices(long long const,Teuchos::ArrayView< long long const > const &)", SWIG_UnknownError, "An unknown exception occurred", return ); } } - } @@ -7521,7 +7642,6 @@ SWIGEXPORT void _wrap_TpetraCrsGraph_insertGlobalIndices__SWIG_1(SwigClassWrappe SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::insertGlobalIndices(long long const,int const,long long const [])", SWIG_UnknownError, "An unknown exception occurred", return ); } } - } @@ -7566,7 +7686,6 @@ SWIGEXPORT void _wrap_TpetraCrsGraph_insertLocalIndices(SwigClassWrapper const * SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::insertLocalIndices(int const,Teuchos::ArrayView< int const > const &)", SWIG_UnknownError, "An unknown exception occurred", return ); } } - } @@ -7601,7 +7720,6 @@ SWIGEXPORT void _wrap_TpetraCrsGraph_removeLocalIndices(SwigClassWrapper const * SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::removeLocalIndices(int)", SWIG_UnknownError, "An unknown exception occurred", return ); } } - } @@ -7634,7 +7752,6 @@ SWIGEXPORT void _wrap_TpetraCrsGraph_globalAssemble(SwigClassWrapper const *farg SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::globalAssemble()", SWIG_UnknownError, "An unknown exception occurred", return ); } } - } @@ -7670,7 +7787,6 @@ SWIGEXPORT void _wrap_TpetraCrsGraph_resumeFill__SWIG_0(SwigClassWrapper const * SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::resumeFill(Teuchos::RCP< Teuchos::ParameterList > const &)", SWIG_UnknownError, "An unknown exception occurred", return ); } } - } @@ -7703,7 +7819,6 @@ SWIGEXPORT void _wrap_TpetraCrsGraph_resumeFill__SWIG_1(SwigClassWrapper const * SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::resumeFill()", SWIG_UnknownError, "An unknown exception occurred", return ); } } - } @@ -7745,7 +7860,6 @@ SWIGEXPORT void _wrap_TpetraCrsGraph_fillComplete__SWIG_0(SwigClassWrapper const SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::fillComplete(Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Teuchos::ParameterList > const &)", SWIG_UnknownError, "An unknown exception occurred", return ); } } - } @@ -7784,7 +7898,6 @@ SWIGEXPORT void _wrap_TpetraCrsGraph_fillComplete__SWIG_1(SwigClassWrapper const SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::fillComplete(Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &)", SWIG_UnknownError, "An unknown exception occurred", return ); } } - } @@ -7820,7 +7933,6 @@ SWIGEXPORT void _wrap_TpetraCrsGraph_fillComplete__SWIG_2(SwigClassWrapper const SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::fillComplete(Teuchos::RCP< Teuchos::ParameterList > const &)", SWIG_UnknownError, "An unknown exception occurred", return ); } } - } @@ -7853,7 +7965,6 @@ SWIGEXPORT void _wrap_TpetraCrsGraph_fillComplete__SWIG_3(SwigClassWrapper const SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::fillComplete()", SWIG_UnknownError, "An unknown exception occurred", return ); } } - } @@ -7901,7 +8012,6 @@ SWIGEXPORT void _wrap_TpetraCrsGraph_expertStaticFillComplete__SWIG_0(SwigClassW SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::expertStaticFillComplete(Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::import_type const > const &,Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::export_type const > const &,Teuchos::RCP< Teuchos::ParameterList > const &)", SWIG_UnknownError, "An unknown exception occurred", return ); } } - } @@ -7946,7 +8056,6 @@ SWIGEXPORT void _wrap_TpetraCrsGraph_expertStaticFillComplete__SWIG_1(SwigClassW SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::expertStaticFillComplete(Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::import_type const > const &,Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::export_type const > const &)", SWIG_UnknownError, "An unknown exception occurred", return ); } } - } @@ -7988,7 +8097,6 @@ SWIGEXPORT void _wrap_TpetraCrsGraph_expertStaticFillComplete__SWIG_2(SwigClassW SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::expertStaticFillComplete(Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::import_type const > const &)", SWIG_UnknownError, "An unknown exception occurred", return ); } } - } @@ -8027,7 +8135,6 @@ SWIGEXPORT void _wrap_TpetraCrsGraph_expertStaticFillComplete__SWIG_3(SwigClassW SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::expertStaticFillComplete(Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &)", SWIG_UnknownError, "An unknown exception occurred", return ); } } - } @@ -9091,7 +9198,6 @@ SWIGEXPORT void _wrap_TpetraCrsGraph_getGlobalRowCopy(SwigClassWrapper const *fa SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::getGlobalRowCopy(long long,Teuchos::ArrayView< long long > const &,size_t &) const", SWIG_UnknownError, "An unknown exception occurred", return ); } } - } @@ -9132,7 +9238,6 @@ SWIGEXPORT void _wrap_TpetraCrsGraph_getLocalRowCopy(SwigClassWrapper const *far SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::getLocalRowCopy(int,Teuchos::ArrayView< int > const &,size_t &) const", SWIG_UnknownError, "An unknown exception occurred", return ); } } - for (int i = 0; i < tmpview3.size(); i++) tmpview3[i] += 1; } @@ -9248,7 +9353,6 @@ SWIGEXPORT void _wrap_TpetraCrsGraph_replaceColMap(SwigClassWrapper const *farg1 SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::replaceColMap(Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &)", SWIG_UnknownError, "An unknown exception occurred", return ); } } - } @@ -9289,7 +9393,6 @@ SWIGEXPORT void _wrap_TpetraCrsGraph_reindexColumns__SWIG_0(SwigClassWrapper con SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::reindexColumns(Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::import_type const > const &,bool const)", SWIG_UnknownError, "An unknown exception occurred", return ); } } - } @@ -9328,7 +9431,6 @@ SWIGEXPORT void _wrap_TpetraCrsGraph_reindexColumns__SWIG_1(SwigClassWrapper con SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::reindexColumns(Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::import_type const > const &)", SWIG_UnknownError, "An unknown exception occurred", return ); } } - } @@ -9364,7 +9466,6 @@ SWIGEXPORT void _wrap_TpetraCrsGraph_reindexColumns__SWIG_2(SwigClassWrapper con SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::reindexColumns(Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &)", SWIG_UnknownError, "An unknown exception occurred", return ); } } - } @@ -9403,7 +9504,6 @@ SWIGEXPORT void _wrap_TpetraCrsGraph_replaceDomainMapAndImporter(SwigClassWrappe SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::replaceDomainMapAndImporter(Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::import_type const > const &)", SWIG_UnknownError, "An unknown exception occurred", return ); } } - } @@ -9439,7 +9539,6 @@ SWIGEXPORT void _wrap_TpetraCrsGraph_removeEmptyProcessesInPlace(SwigClassWrappe SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::removeEmptyProcessesInPlace(Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &)", SWIG_UnknownError, "An unknown exception occurred", return ); } } - } @@ -9489,7 +9588,6 @@ SWIGEXPORT void _wrap_TpetraCrsGraph_importAndFillComplete__SWIG_0(SwigClassWrap SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::importAndFillComplete(Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode > > &,Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::import_type const &,Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Teuchos::ParameterList > const &) const", SWIG_UnknownError, "An unknown exception occurred", return ); } } - } @@ -9536,7 +9634,6 @@ SWIGEXPORT void _wrap_TpetraCrsGraph_importAndFillComplete__SWIG_1(SwigClassWrap SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::importAndFillComplete(Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode > > &,Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::import_type const &,Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &) const", SWIG_UnknownError, "An unknown exception occurred", return ); } } - } @@ -9591,7 +9688,6 @@ SWIGEXPORT void _wrap_TpetraCrsGraph_importAndFillComplete__SWIG_2(SwigClassWrap SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::importAndFillComplete(Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode > > &,Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::import_type const &,Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::import_type const &,Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Teuchos::ParameterList > const &) const", SWIG_UnknownError, "An unknown exception occurred", return ); } } - } @@ -9641,7 +9737,6 @@ SWIGEXPORT void _wrap_TpetraCrsGraph_exportAndFillComplete__SWIG_0(SwigClassWrap SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::exportAndFillComplete(Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode > > &,Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::export_type const &,Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Teuchos::ParameterList > const &) const", SWIG_UnknownError, "An unknown exception occurred", return ); } } - } @@ -9688,7 +9783,6 @@ SWIGEXPORT void _wrap_TpetraCrsGraph_exportAndFillComplete__SWIG_1(SwigClassWrap SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::exportAndFillComplete(Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode > > &,Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::export_type const &,Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &) const", SWIG_UnknownError, "An unknown exception occurred", return ); } } - } @@ -9732,7 +9826,6 @@ SWIGEXPORT void _wrap_TpetraCrsGraph_exportAndFillComplete__SWIG_2(SwigClassWrap SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::exportAndFillComplete(Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode > > &,Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::export_type const &,Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &) const", SWIG_UnknownError, "An unknown exception occurred", return ); } } - } @@ -9773,7 +9866,6 @@ SWIGEXPORT void _wrap_TpetraCrsGraph_exportAndFillComplete__SWIG_3(SwigClassWrap SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::exportAndFillComplete(Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode > > &,Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::export_type const &) const", SWIG_UnknownError, "An unknown exception occurred", return ); } } - } @@ -9828,7 +9920,6 @@ SWIGEXPORT void _wrap_TpetraCrsGraph_exportAndFillComplete__SWIG_4(SwigClassWrap SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::exportAndFillComplete(Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode > > &,Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::export_type const &,Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::export_type const &,Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::CrsGraph< int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Teuchos::ParameterList > const &) const", SWIG_UnknownError, "An unknown exception occurred", return ); } } - } @@ -9899,7 +9990,6 @@ SWIGEXPORT void _wrap_TpetraCrsGraph_computeGlobalConstants(SwigClassWrapper con SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::computeGlobalConstants(bool const)", SWIG_UnknownError, "An unknown exception occurred", return ); } } - } @@ -9934,7 +10024,6 @@ SWIGEXPORT void _wrap_TpetraCrsGraph_getNodeRowPtrs(SwigClassWrapper const *farg SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::getNodeRowPtrs(Teuchos::ArrayView< std::size_t >) const", SWIG_UnknownError, "An unknown exception occurred", return ); } } - } @@ -9969,7 +10058,6 @@ SWIGEXPORT void _wrap_TpetraCrsGraph_getNodePackedIndices(SwigClassWrapper const SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::getNodePackedIndices(Teuchos::ArrayView< std::size_t >) const", SWIG_UnknownError, "An unknown exception occurred", return ); } } - } @@ -10014,7 +10102,6 @@ SWIGEXPORT void _wrap_TpetraCrsGraph_doImport__SWIG_0(SwigClassWrapper const *fa SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::doImport(Tpetra::CrsGraph< LO,GO,NO > const &,Tpetra::Import< LO,GO,NO > const &,Tpetra::CombineMode)", SWIG_UnknownError, "An unknown exception occurred", return ); } } - } @@ -10059,7 +10146,6 @@ SWIGEXPORT void _wrap_TpetraCrsGraph_doImport__SWIG_1(SwigClassWrapper const *fa SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::doImport(Tpetra::CrsGraph< LO,GO,NO > const &,Tpetra::Export< LO,GO,NO > const &,Tpetra::CombineMode)", SWIG_UnknownError, "An unknown exception occurred", return ); } } - } @@ -10104,7 +10190,6 @@ SWIGEXPORT void _wrap_TpetraCrsGraph_doExport__SWIG_0(SwigClassWrapper const *fa SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::doExport(Tpetra::CrsGraph< LO,GO,NO > const &,Tpetra::Export< LO,GO,NO > const &,Tpetra::CombineMode)", SWIG_UnknownError, "An unknown exception occurred", return ); } } - } @@ -10149,15 +10234,41 @@ SWIGEXPORT void _wrap_TpetraCrsGraph_doExport__SWIG_1(SwigClassWrapper const *fa SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::doExport(Tpetra::CrsGraph< LO,GO,NO > const &,Tpetra::Import< LO,GO,NO > const &,Tpetra::CombineMode)", SWIG_UnknownError, "An unknown exception occurred", return ); } } - } -SWIGEXPORT void _wrap_assign_TpetraCrsGraph(SwigClassWrapper * self, SwigClassWrapper const * other) { - typedef Teuchos::RCP< Tpetra::CrsGraph > swig_lhs_classtype; - SWIG_assign(swig_lhs_classtype, self, - swig_lhs_classtype, const_cast(other), - 0 | swig::IS_DESTR | swig::IS_COPY_CONSTR); +SWIGEXPORT void _wrap_TpetraCrsGraph_op_assign__(SwigClassWrapper *farg1, SwigClassWrapper const *farg2) { + Tpetra::CrsGraph< LO,GO,NO > *arg1 = (Tpetra::CrsGraph< LO,GO,NO > *) 0 ; + Tpetra::CrsGraph< LO,GO,NO > *arg2 = 0 ; + Teuchos::RCP< Tpetra::CrsGraph< LO,GO,NO > > *smartarg1 ; + + smartarg1 = static_cast< Teuchos::RCP< Tpetra::CrsGraph >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::CrsGraph* >(smartarg1->get()) : NULL; + (void)sizeof(arg2); + { + // Make sure no unhandled exceptions exist before performing a new action + SWIG_check_unhandled_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::operator =(Tpetra::CrsGraph< LO,GO,NO > const &)");; + try + { + // Attempt the wrapped function call + typedef Teuchos::RCP< Tpetra::CrsGraph > swig_lhs_classtype; + SWIG_assign(swig_lhs_classtype, farg1, swig_lhs_classtype, farg2, 0 | swig::IS_DESTR | swig::IS_COPY_CONSTR); + } + catch (const std::range_error& e) + { + // Store a C++ exception + SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::operator =(Tpetra::CrsGraph< LO,GO,NO > const &)", SWIG_IndexError, e.what(), return ); + } + catch (const std::exception& e) + { + // Store a C++ exception + SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::operator =(Tpetra::CrsGraph< LO,GO,NO > const &)", SWIG_RuntimeError, e.what(), return ); + } + catch (...) + { + SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::operator =(Tpetra::CrsGraph< LO,GO,NO > const &)", SWIG_UnknownError, "An unknown exception occurred", return ); + } + } } @@ -10960,7 +11071,7 @@ SWIGEXPORT SwigClassWrapper _wrap_new_TpetraCrsMatrix__SWIG_17(SwigClassWrapper } -SWIGEXPORT void _wrap_delete_TpetraCrsMatrix(SwigClassWrapper const *farg1) { +SWIGEXPORT void _wrap_delete_TpetraCrsMatrix(SwigClassWrapper *farg1) { Tpetra::CrsMatrix< SC,LO,GO,NO > *arg1 = (Tpetra::CrsMatrix< SC,LO,GO,NO > *) 0 ; Teuchos::RCP< Tpetra::CrsMatrix< SC,LO,GO,NO > > *smartarg1 ; @@ -10989,7 +11100,6 @@ SWIGEXPORT void _wrap_delete_TpetraCrsMatrix(SwigClassWrapper const *farg1) { SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::~CrsMatrix()", SWIG_UnknownError, "An unknown exception occurred", return ); } } - } @@ -11032,7 +11142,6 @@ SWIGEXPORT void _wrap_TpetraCrsMatrix_insertGlobalValues(SwigClassWrapper const SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::insertGlobalValues(long long const,Teuchos::ArrayView< long long const > const &,Teuchos::ArrayView< double const > const &)", SWIG_UnknownError, "An unknown exception occurred", return ); } } - } @@ -11081,7 +11190,6 @@ SWIGEXPORT void _wrap_TpetraCrsMatrix_insertLocalValues(SwigClassWrapper const * SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::insertLocalValues(int const,Teuchos::ArrayView< int const > const &,Teuchos::ArrayView< double const > const &)", SWIG_UnknownError, "An unknown exception occurred", return ); } } - } @@ -11366,7 +11474,6 @@ SWIGEXPORT void _wrap_TpetraCrsMatrix_setAllToScalar(SwigClassWrapper const *far SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::setAllToScalar(double const &)", SWIG_UnknownError, "An unknown exception occurred", return ); } } - } @@ -11403,7 +11510,6 @@ SWIGEXPORT void _wrap_TpetraCrsMatrix_scale(SwigClassWrapper const *farg1, doubl SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::scale(double const &)", SWIG_UnknownError, "An unknown exception occurred", return ); } } - } @@ -11460,7 +11566,6 @@ SWIGEXPORT void _wrap_TpetraCrsMatrix_setAllValues(SwigClassWrapper const *farg1 SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::setAllValues(Teuchos::ArrayRCP< std::size_t > const &,Teuchos::ArrayRCP< int > const &,Teuchos::ArrayRCP< double > const &)", SWIG_UnknownError, "An unknown exception occurred", return ); } } - } @@ -11493,7 +11598,6 @@ SWIGEXPORT void _wrap_TpetraCrsMatrix_globalAssemble(SwigClassWrapper const *far SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::globalAssemble()", SWIG_UnknownError, "An unknown exception occurred", return ); } } - } @@ -11529,7 +11633,6 @@ SWIGEXPORT void _wrap_TpetraCrsMatrix_resumeFill__SWIG_0(SwigClassWrapper const SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::resumeFill(Teuchos::RCP< Teuchos::ParameterList > const &)", SWIG_UnknownError, "An unknown exception occurred", return ); } } - } @@ -11562,7 +11665,6 @@ SWIGEXPORT void _wrap_TpetraCrsMatrix_resumeFill__SWIG_1(SwigClassWrapper const SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::resumeFill()", SWIG_UnknownError, "An unknown exception occurred", return ); } } - } @@ -11604,7 +11706,6 @@ SWIGEXPORT void _wrap_TpetraCrsMatrix_fillComplete__SWIG_0(SwigClassWrapper cons SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::fillComplete(Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Teuchos::ParameterList > const &)", SWIG_UnknownError, "An unknown exception occurred", return ); } } - } @@ -11643,7 +11744,6 @@ SWIGEXPORT void _wrap_TpetraCrsMatrix_fillComplete__SWIG_1(SwigClassWrapper cons SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::fillComplete(Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &)", SWIG_UnknownError, "An unknown exception occurred", return ); } } - } @@ -11679,7 +11779,6 @@ SWIGEXPORT void _wrap_TpetraCrsMatrix_fillComplete__SWIG_2(SwigClassWrapper cons SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::fillComplete(Teuchos::RCP< Teuchos::ParameterList > const &)", SWIG_UnknownError, "An unknown exception occurred", return ); } } - } @@ -11712,7 +11811,6 @@ SWIGEXPORT void _wrap_TpetraCrsMatrix_fillComplete__SWIG_3(SwigClassWrapper cons SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::fillComplete()", SWIG_UnknownError, "An unknown exception occurred", return ); } } - } @@ -11760,7 +11858,6 @@ SWIGEXPORT void _wrap_TpetraCrsMatrix_expertStaticFillComplete__SWIG_0(SwigClass SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::expertStaticFillComplete(Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::import_type const > const &,Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::export_type const > const &,Teuchos::RCP< Teuchos::ParameterList > const &)", SWIG_UnknownError, "An unknown exception occurred", return ); } } - } @@ -11805,7 +11902,6 @@ SWIGEXPORT void _wrap_TpetraCrsMatrix_expertStaticFillComplete__SWIG_1(SwigClass SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::expertStaticFillComplete(Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::import_type const > const &,Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::export_type const > const &)", SWIG_UnknownError, "An unknown exception occurred", return ); } } - } @@ -11847,7 +11943,6 @@ SWIGEXPORT void _wrap_TpetraCrsMatrix_expertStaticFillComplete__SWIG_2(SwigClass SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::expertStaticFillComplete(Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::import_type const > const &)", SWIG_UnknownError, "An unknown exception occurred", return ); } } - } @@ -11886,7 +11981,6 @@ SWIGEXPORT void _wrap_TpetraCrsMatrix_expertStaticFillComplete__SWIG_3(SwigClass SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::expertStaticFillComplete(Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &)", SWIG_UnknownError, "An unknown exception occurred", return ); } } - } @@ -11922,7 +12016,6 @@ SWIGEXPORT void _wrap_TpetraCrsMatrix_replaceColMap(SwigClassWrapper const *farg SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::replaceColMap(Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &)", SWIG_UnknownError, "An unknown exception occurred", return ); } } - } @@ -11967,7 +12060,6 @@ SWIGEXPORT void _wrap_TpetraCrsMatrix_reindexColumns__SWIG_0(SwigClassWrapper co SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::reindexColumns(Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::crs_graph_type *const,Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::import_type const > const &,bool const)", SWIG_UnknownError, "An unknown exception occurred", return ); } } - } @@ -12010,7 +12102,6 @@ SWIGEXPORT void _wrap_TpetraCrsMatrix_reindexColumns__SWIG_1(SwigClassWrapper co SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::reindexColumns(Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::crs_graph_type *const,Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::import_type const > const &)", SWIG_UnknownError, "An unknown exception occurred", return ); } } - } @@ -12050,7 +12141,6 @@ SWIGEXPORT void _wrap_TpetraCrsMatrix_reindexColumns__SWIG_2(SwigClassWrapper co SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::reindexColumns(Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::crs_graph_type *const,Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &)", SWIG_UnknownError, "An unknown exception occurred", return ); } } - } @@ -12089,7 +12179,6 @@ SWIGEXPORT void _wrap_TpetraCrsMatrix_replaceDomainMapAndImporter(SwigClassWrapp SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::replaceDomainMapAndImporter(Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::import_type const > &)", SWIG_UnknownError, "An unknown exception occurred", return ); } } - } @@ -12125,7 +12214,6 @@ SWIGEXPORT void _wrap_TpetraCrsMatrix_removeEmptyProcessesInPlace(SwigClassWrapp SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::removeEmptyProcessesInPlace(Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &)", SWIG_UnknownError, "An unknown exception occurred", return ); } } - } @@ -13042,7 +13130,6 @@ SWIGEXPORT void _wrap_TpetraCrsMatrix_getGlobalRowCopy(SwigClassWrapper const *f SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::getGlobalRowCopy(long long,Teuchos::ArrayView< long long > const &,Teuchos::ArrayView< double > const &,size_t &) const", SWIG_UnknownError, "An unknown exception occurred", return ); } } - } @@ -13087,7 +13174,6 @@ SWIGEXPORT void _wrap_TpetraCrsMatrix_getLocalRowCopy(SwigClassWrapper const *fa SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::getLocalRowCopy(int,Teuchos::ArrayView< int > const &,Teuchos::ArrayView< double > const &,size_t &) const", SWIG_UnknownError, "An unknown exception occurred", return ); } } - for (int i = 0; i < tmpview3.size(); i++) tmpview3[i] += 1; } @@ -13132,7 +13218,6 @@ SWIGEXPORT void _wrap_TpetraCrsMatrix_getGlobalRowView(SwigClassWrapper const *f SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::getGlobalRowView(long long,Teuchos::ArrayView< long long const > &,Teuchos::ArrayView< double const > &) const", SWIG_UnknownError, "An unknown exception occurred", return ); } } - farg3->data = (void*)tmpview3.getRawPtr(); farg3->size = tmpview3.size(); farg4->data = (void*)tmpview4.getRawPtr(); @@ -13172,7 +13257,6 @@ SWIGEXPORT void _wrap_TpetraCrsMatrix_getLocalDiagOffsets(SwigClassWrapper const SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::getLocalDiagOffsets(Teuchos::ArrayRCP< std::size_t > &) const", SWIG_UnknownError, "An unknown exception occurred", return ); } } - } @@ -13221,7 +13305,6 @@ SWIGEXPORT void _wrap_TpetraCrsMatrix_apply__SWIG_0(SwigClassWrapper const *farg SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::apply(Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &,Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > &,Teuchos::ETransp,double,double) const", SWIG_UnknownError, "An unknown exception occurred", return ); } } - } @@ -13268,7 +13351,6 @@ SWIGEXPORT void _wrap_TpetraCrsMatrix_apply__SWIG_1(SwigClassWrapper const *farg SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::apply(Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &,Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > &,Teuchos::ETransp,double) const", SWIG_UnknownError, "An unknown exception occurred", return ); } } - } @@ -13313,7 +13395,6 @@ SWIGEXPORT void _wrap_TpetraCrsMatrix_apply__SWIG_2(SwigClassWrapper const *farg SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::apply(Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &,Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > &,Teuchos::ETransp) const", SWIG_UnknownError, "An unknown exception occurred", return ); } } - } @@ -13356,7 +13437,6 @@ SWIGEXPORT void _wrap_TpetraCrsMatrix_apply__SWIG_3(SwigClassWrapper const *farg SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::apply(Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &,Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > &) const", SWIG_UnknownError, "An unknown exception occurred", return ); } } - } @@ -13522,7 +13602,6 @@ SWIGEXPORT void _wrap_TpetraCrsMatrix_gaussSeidel(SwigClassWrapper const *farg1, SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::gaussSeidel(Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &,Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > &,Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &,double const &,Tpetra::ESweepDirection const,int const) const", SWIG_UnknownError, "An unknown exception occurred", return ); } } - } @@ -13580,7 +13659,6 @@ SWIGEXPORT void _wrap_TpetraCrsMatrix_gaussSeidelCopy(SwigClassWrapper const *fa SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::gaussSeidelCopy(Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > &,Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &,Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &,double const &,Tpetra::ESweepDirection const,int const,bool const) const", SWIG_UnknownError, "An unknown exception occurred", return ); } } - } @@ -13672,7 +13750,6 @@ SWIGEXPORT void _wrap_TpetraCrsMatrix_importAndFillComplete__SWIG_0(SwigClassWra SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::importAndFillComplete(Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > > &,Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::import_type const &,Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Teuchos::ParameterList > const &) const", SWIG_UnknownError, "An unknown exception occurred", return ); } } - } @@ -13719,7 +13796,6 @@ SWIGEXPORT void _wrap_TpetraCrsMatrix_importAndFillComplete__SWIG_1(SwigClassWra SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::importAndFillComplete(Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > > &,Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::import_type const &,Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &) const", SWIG_UnknownError, "An unknown exception occurred", return ); } } - } @@ -13774,7 +13850,6 @@ SWIGEXPORT void _wrap_TpetraCrsMatrix_importAndFillComplete__SWIG_2(SwigClassWra SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::importAndFillComplete(Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > > &,Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::import_type const &,Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::import_type const &,Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Teuchos::ParameterList > const &) const", SWIG_UnknownError, "An unknown exception occurred", return ); } } - } @@ -13824,7 +13899,6 @@ SWIGEXPORT void _wrap_TpetraCrsMatrix_exportAndFillComplete__SWIG_0(SwigClassWra SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::exportAndFillComplete(Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > > &,Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::export_type const &,Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Teuchos::ParameterList > const &) const", SWIG_UnknownError, "An unknown exception occurred", return ); } } - } @@ -13871,7 +13945,6 @@ SWIGEXPORT void _wrap_TpetraCrsMatrix_exportAndFillComplete__SWIG_1(SwigClassWra SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::exportAndFillComplete(Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > > &,Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::export_type const &,Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &) const", SWIG_UnknownError, "An unknown exception occurred", return ); } } - } @@ -13915,7 +13988,6 @@ SWIGEXPORT void _wrap_TpetraCrsMatrix_exportAndFillComplete__SWIG_2(SwigClassWra SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::exportAndFillComplete(Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > > &,Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::export_type const &,Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &) const", SWIG_UnknownError, "An unknown exception occurred", return ); } } - } @@ -13956,7 +14028,6 @@ SWIGEXPORT void _wrap_TpetraCrsMatrix_exportAndFillComplete__SWIG_3(SwigClassWra SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::exportAndFillComplete(Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > > &,Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::export_type const &) const", SWIG_UnknownError, "An unknown exception occurred", return ); } } - } @@ -14011,7 +14082,6 @@ SWIGEXPORT void _wrap_TpetraCrsMatrix_exportAndFillComplete__SWIG_4(SwigClassWra SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::exportAndFillComplete(Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > > &,Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::export_type const &,Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::export_type const &,Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > const &,Teuchos::RCP< Teuchos::ParameterList > const &) const", SWIG_UnknownError, "An unknown exception occurred", return ); } } - } @@ -14044,7 +14114,6 @@ SWIGEXPORT void _wrap_TpetraCrsMatrix_computeGlobalConstants(SwigClassWrapper co SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::computeGlobalConstants()", SWIG_UnknownError, "An unknown exception occurred", return ); } } - } @@ -14119,15 +14188,41 @@ SWIGEXPORT void _wrap_TpetraCrsMatrix_getAllValues(SwigClassWrapper const *farg1 SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::getAllValues(Teuchos::ArrayView< std::size_t >,Teuchos::ArrayView< LO >,Teuchos::ArrayView< SC >) const", SWIG_UnknownError, "An unknown exception occurred", return ); } } - } -SWIGEXPORT void _wrap_assign_TpetraCrsMatrix(SwigClassWrapper * self, SwigClassWrapper const * other) { - typedef Teuchos::RCP< Tpetra::CrsMatrix > swig_lhs_classtype; - SWIG_assign(swig_lhs_classtype, self, - swig_lhs_classtype, const_cast(other), - 0 | swig::IS_DESTR); +SWIGEXPORT void _wrap_TpetraCrsMatrix_op_assign__(SwigClassWrapper *farg1, SwigClassWrapper const *farg2) { + Tpetra::CrsMatrix< SC,LO,GO,NO > *arg1 = (Tpetra::CrsMatrix< SC,LO,GO,NO > *) 0 ; + Tpetra::CrsMatrix< SC,LO,GO,NO > *arg2 = 0 ; + Teuchos::RCP< Tpetra::CrsMatrix< SC,LO,GO,NO > > *smartarg1 ; + + smartarg1 = static_cast< Teuchos::RCP< Tpetra::CrsMatrix >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::CrsMatrix* >(smartarg1->get()) : NULL; + (void)sizeof(arg2); + { + // Make sure no unhandled exceptions exist before performing a new action + SWIG_check_unhandled_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::operator =(Tpetra::CrsMatrix< SC,LO,GO,NO > const &)");; + try + { + // Attempt the wrapped function call + typedef Teuchos::RCP< Tpetra::CrsMatrix > swig_lhs_classtype; + SWIG_assign(swig_lhs_classtype, farg1, swig_lhs_classtype, farg2, 0 | swig::IS_DESTR); + } + catch (const std::range_error& e) + { + // Store a C++ exception + SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::operator =(Tpetra::CrsMatrix< SC,LO,GO,NO > const &)", SWIG_IndexError, e.what(), return ); + } + catch (const std::exception& e) + { + // Store a C++ exception + SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::operator =(Tpetra::CrsMatrix< SC,LO,GO,NO > const &)", SWIG_RuntimeError, e.what(), return ); + } + catch (...) + { + SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::operator =(Tpetra::CrsMatrix< SC,LO,GO,NO > const &)", SWIG_UnknownError, "An unknown exception occurred", return ); + } + } } @@ -14740,7 +14835,7 @@ SWIGEXPORT SwigClassWrapper _wrap_TpetraReader_readMapFile(SwigArrayWrapper *far } -SWIGEXPORT void _wrap_delete_TpetraReader(SwigClassWrapper const *farg1) { +SWIGEXPORT void _wrap_delete_TpetraReader(SwigClassWrapper *farg1) { Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > > *arg1 = (Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > > *) 0 ; Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > > > *smartarg1 ; @@ -14769,15 +14864,41 @@ SWIGEXPORT void _wrap_delete_TpetraReader(SwigClassWrapper const *farg1) { SWIG_exception_impl("Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::~Reader()", SWIG_UnknownError, "An unknown exception occurred", return ); } } - } -SWIGEXPORT void _wrap_assign_TpetraReader(SwigClassWrapper * self, SwigClassWrapper const * other) { - typedef Teuchos::RCP< Tpetra::MatrixMarket::Reader > > swig_lhs_classtype; - SWIG_assign(swig_lhs_classtype, self, - swig_lhs_classtype, const_cast(other), - 0 | swig::IS_DESTR | swig::IS_COPY_CONSTR); +SWIGEXPORT void _wrap_TpetraReader_op_assign__(SwigClassWrapper *farg1, SwigClassWrapper const *farg2) { + Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > > *arg1 = (Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > > *) 0 ; + Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > > *arg2 = 0 ; + Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > > > *smartarg1 ; + + smartarg1 = static_cast< Teuchos::RCP< Tpetra::MatrixMarket::Reader > >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::MatrixMarket::Reader >* >(smartarg1->get()) : NULL; + (void)sizeof(arg2); + { + // Make sure no unhandled exceptions exist before performing a new action + SWIG_check_unhandled_exception_impl("Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::operator =(Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > > const &)");; + try + { + // Attempt the wrapped function call + typedef Teuchos::RCP< Tpetra::MatrixMarket::Reader > > swig_lhs_classtype; + SWIG_assign(swig_lhs_classtype, farg1, swig_lhs_classtype, farg2, 0 | swig::IS_DESTR | swig::IS_COPY_CONSTR); + } + catch (const std::range_error& e) + { + // Store a C++ exception + SWIG_exception_impl("Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::operator =(Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > > const &)", SWIG_IndexError, e.what(), return ); + } + catch (const std::exception& e) + { + // Store a C++ exception + SWIG_exception_impl("Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::operator =(Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > > const &)", SWIG_RuntimeError, e.what(), return ); + } + catch (...) + { + SWIG_exception_impl("Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::operator =(Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > > const &)", SWIG_UnknownError, "An unknown exception occurred", return ); + } + } } @@ -14821,7 +14942,6 @@ SWIGEXPORT void _wrap_TpetraWriter_writeSparseFile__SWIG_0(SwigArrayWrapper *far SWIG_exception_impl("Tpetra::MatrixMarket::Writer< Tpetra::CrsMatrix< SC,LO,GO,NO > >::writeSparseFile(std::string const &,Teuchos::RCP< Tpetra::MatrixMarket::Writer< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > >::sparse_matrix_type const > const &,std::string const &,std::string const &)", SWIG_UnknownError, "An unknown exception occurred", return ); } } - } @@ -14857,7 +14977,6 @@ SWIGEXPORT void _wrap_TpetraWriter_writeSparseFile__SWIG_1(SwigArrayWrapper *far SWIG_exception_impl("Tpetra::MatrixMarket::Writer< Tpetra::CrsMatrix< SC,LO,GO,NO > >::writeSparseFile(std::string const &,Teuchos::RCP< Tpetra::MatrixMarket::Writer< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > >::sparse_matrix_type const > const &)", SWIG_UnknownError, "An unknown exception occurred", return ); } } - } @@ -14901,7 +15020,6 @@ SWIGEXPORT void _wrap_TpetraWriter_writeSparseGraphFile__SWIG_0(SwigArrayWrapper SWIG_exception_impl("Tpetra::MatrixMarket::Writer< Tpetra::CrsMatrix< SC,LO,GO,NO > >::writeSparseGraphFile(std::string const &,Teuchos::RCP< Tpetra::MatrixMarket::Writer< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > >::crs_graph_type const > const &,std::string const &,std::string const &)", SWIG_UnknownError, "An unknown exception occurred", return ); } } - } @@ -14937,7 +15055,6 @@ SWIGEXPORT void _wrap_TpetraWriter_writeSparseGraphFile__SWIG_1(SwigArrayWrapper SWIG_exception_impl("Tpetra::MatrixMarket::Writer< Tpetra::CrsMatrix< SC,LO,GO,NO > >::writeSparseGraphFile(std::string const &,Teuchos::RCP< Tpetra::MatrixMarket::Writer< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > >::crs_graph_type const > const &)", SWIG_UnknownError, "An unknown exception occurred", return ); } } - } @@ -14981,7 +15098,6 @@ SWIGEXPORT void _wrap_TpetraWriter_writeDenseFile__SWIG_0(SwigArrayWrapper *farg SWIG_exception_impl("Tpetra::MatrixMarket::Writer< Tpetra::CrsMatrix< SC,LO,GO,NO > >::writeDenseFile(std::string const &,Teuchos::RCP< Tpetra::MatrixMarket::Writer< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > >::multivector_type const > const &,std::string const &,std::string const &)", SWIG_UnknownError, "An unknown exception occurred", return ); } } - } @@ -15017,11 +15133,10 @@ SWIGEXPORT void _wrap_TpetraWriter_writeDenseFile__SWIG_1(SwigArrayWrapper *farg SWIG_exception_impl("Tpetra::MatrixMarket::Writer< Tpetra::CrsMatrix< SC,LO,GO,NO > >::writeDenseFile(std::string const &,Teuchos::RCP< Tpetra::MatrixMarket::Writer< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > >::multivector_type const > const &)", SWIG_UnknownError, "An unknown exception occurred", return ); } } - } -SWIGEXPORT void _wrap_delete_TpetraWriter(SwigClassWrapper const *farg1) { +SWIGEXPORT void _wrap_delete_TpetraWriter(SwigClassWrapper *farg1) { Tpetra::MatrixMarket::Writer< Tpetra::CrsMatrix< SC,LO,GO,NO > > *arg1 = (Tpetra::MatrixMarket::Writer< Tpetra::CrsMatrix< SC,LO,GO,NO > > *) 0 ; Teuchos::RCP< Tpetra::MatrixMarket::Writer< Tpetra::CrsMatrix< SC,LO,GO,NO > > > *smartarg1 ; @@ -15050,15 +15165,41 @@ SWIGEXPORT void _wrap_delete_TpetraWriter(SwigClassWrapper const *farg1) { SWIG_exception_impl("Tpetra::MatrixMarket::Writer< Tpetra::CrsMatrix< SC,LO,GO,NO > >::~Writer()", SWIG_UnknownError, "An unknown exception occurred", return ); } } - } -SWIGEXPORT void _wrap_assign_TpetraWriter(SwigClassWrapper * self, SwigClassWrapper const * other) { - typedef Teuchos::RCP< Tpetra::MatrixMarket::Writer > > swig_lhs_classtype; - SWIG_assign(swig_lhs_classtype, self, - swig_lhs_classtype, const_cast(other), - 0 | swig::IS_DESTR | swig::IS_COPY_CONSTR); +SWIGEXPORT void _wrap_TpetraWriter_op_assign__(SwigClassWrapper *farg1, SwigClassWrapper const *farg2) { + Tpetra::MatrixMarket::Writer< Tpetra::CrsMatrix< SC,LO,GO,NO > > *arg1 = (Tpetra::MatrixMarket::Writer< Tpetra::CrsMatrix< SC,LO,GO,NO > > *) 0 ; + Tpetra::MatrixMarket::Writer< Tpetra::CrsMatrix< SC,LO,GO,NO > > *arg2 = 0 ; + Teuchos::RCP< Tpetra::MatrixMarket::Writer< Tpetra::CrsMatrix< SC,LO,GO,NO > > > *smartarg1 ; + + smartarg1 = static_cast< Teuchos::RCP< Tpetra::MatrixMarket::Writer > >* >(farg1->cptr); + arg1 = smartarg1 ? const_cast< Tpetra::MatrixMarket::Writer >* >(smartarg1->get()) : NULL; + (void)sizeof(arg2); + { + // Make sure no unhandled exceptions exist before performing a new action + SWIG_check_unhandled_exception_impl("Tpetra::MatrixMarket::Writer< Tpetra::CrsMatrix< SC,LO,GO,NO > >::operator =(Tpetra::MatrixMarket::Writer< Tpetra::CrsMatrix< SC,LO,GO,NO > > const &)");; + try + { + // Attempt the wrapped function call + typedef Teuchos::RCP< Tpetra::MatrixMarket::Writer > > swig_lhs_classtype; + SWIG_assign(swig_lhs_classtype, farg1, swig_lhs_classtype, farg2, 0 | swig::IS_DESTR | swig::IS_COPY_CONSTR); + } + catch (const std::range_error& e) + { + // Store a C++ exception + SWIG_exception_impl("Tpetra::MatrixMarket::Writer< Tpetra::CrsMatrix< SC,LO,GO,NO > >::operator =(Tpetra::MatrixMarket::Writer< Tpetra::CrsMatrix< SC,LO,GO,NO > > const &)", SWIG_IndexError, e.what(), return ); + } + catch (const std::exception& e) + { + // Store a C++ exception + SWIG_exception_impl("Tpetra::MatrixMarket::Writer< Tpetra::CrsMatrix< SC,LO,GO,NO > >::operator =(Tpetra::MatrixMarket::Writer< Tpetra::CrsMatrix< SC,LO,GO,NO > > const &)", SWIG_RuntimeError, e.what(), return ); + } + catch (...) + { + SWIG_exception_impl("Tpetra::MatrixMarket::Writer< Tpetra::CrsMatrix< SC,LO,GO,NO > >::operator =(Tpetra::MatrixMarket::Writer< Tpetra::CrsMatrix< SC,LO,GO,NO > > const &)", SWIG_UnknownError, "An unknown exception occurred", return ); + } + } } @@ -15115,7 +15256,6 @@ SWIGEXPORT void _wrap_TpetraMatrixMatrixMultiply__SWIG_0(SwigClassWrapper const SWIG_exception_impl("Tpetra::MatrixMatrix::Multiply< SC,LO,GO,NO >(Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &,bool,Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &,bool,Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > &,bool,std::string const &,Teuchos::RCP< Teuchos::ParameterList > const &)", SWIG_UnknownError, "An unknown exception occurred", return ); } } - } @@ -15169,7 +15309,6 @@ SWIGEXPORT void _wrap_TpetraMatrixMatrixMultiply__SWIG_1(SwigClassWrapper const SWIG_exception_impl("Tpetra::MatrixMatrix::Multiply< SC,LO,GO,NO >(Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &,bool,Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &,bool,Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > &,bool,std::string const &)", SWIG_UnknownError, "An unknown exception occurred", return ); } } - } @@ -15219,7 +15358,6 @@ SWIGEXPORT void _wrap_TpetraMatrixMatrixMultiply__SWIG_2(SwigClassWrapper const SWIG_exception_impl("Tpetra::MatrixMatrix::Multiply< SC,LO,GO,NO >(Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &,bool,Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &,bool,Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > &,bool)", SWIG_UnknownError, "An unknown exception occurred", return ); } } - } @@ -15267,7 +15405,6 @@ SWIGEXPORT void _wrap_TpetraMatrixMatrixMultiply__SWIG_3(SwigClassWrapper const SWIG_exception_impl("Tpetra::MatrixMatrix::Multiply< SC,LO,GO,NO >(Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &,bool,Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &,bool,Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > &)", SWIG_UnknownError, "An unknown exception occurred", return ); } } - } @@ -15312,7 +15449,6 @@ SWIGEXPORT void _wrap_TpetraMatrixMatrixAdd__SWIG_0(SwigClassWrapper const *farg SWIG_exception_impl("Tpetra::MatrixMatrix::Add< SC,LO,GO,NO >(Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &,bool,double,Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > &,double)", SWIG_UnknownError, "An unknown exception occurred", return ); } } - } @@ -15361,7 +15497,6 @@ SWIGEXPORT void _wrap_TpetraMatrixMatrixAdd__SWIG_1(SwigClassWrapper const *farg SWIG_exception_impl("Tpetra::MatrixMatrix::Add< SC,LO,GO,NO >(Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &,bool,double,Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &,bool,double,Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > >)", SWIG_UnknownError, "An unknown exception occurred", return ); } } - } diff --git a/src/utils/src/swig/forerror.F90 b/src/utils/src/swig/forerror.F90 index 68d591ca..d8d057fd 100644 --- a/src/utils/src/swig/forerror.F90 +++ b/src/utils/src/swig/forerror.F90 @@ -62,7 +62,6 @@ function fortrilinos_get_serr() & result(swig_result) use, intrinsic :: ISO_C_BINDING character(kind=C_CHAR, len=:), allocatable :: swig_result - type(SwigArrayWrapper) :: fresult fresult = swigc_fortrilinos_get_serr() diff --git a/swig_hash b/swig_hash index f0c3ced0..d0a89e3f 100644 --- a/swig_hash +++ b/swig_hash @@ -1 +1 @@ -a7ee77f2760b7db3962f091b36407d544e7f0037 +73c02247682d52d61ae6bd48b4c88ea4cdb803d9 From f14c2995003b9308ae43b7e27202c89276899cad Mon Sep 17 00:00:00 2001 From: Seth R Johnson Date: Thu, 21 Mar 2019 11:48:53 -0400 Subject: [PATCH 34/40] Update to latest SWIG master - Updates memory management/assignment semantics - Fixes some latent type issues --- src/belos/src/swig/forbelos.F90 | 31 +- src/belos/src/swig/forbelosFORTRAN_wrap.cxx | 347 +++---- src/interface/src/nox.i | 24 +- src/interface/src/swig/fortrilinos.F90 | 197 ++-- .../src/swig/fortrilinosFORTRAN_wrap.cxx | 579 ++++------- src/teuchos/src/swig/forteuchos.F90 | 111 +-- .../src/swig/forteuchosFORTRAN_wrap.cxx | 509 +++------- src/tpetra/src/Tpetra_Operator.i | 10 +- src/tpetra/src/swig/fortpetra.F90 | 210 ++-- src/tpetra/src/swig/fortpetraFORTRAN_wrap.cxx | 911 ++++++------------ src/utils/src/swig/forerrorFORTRAN_wrap.cxx | 6 +- swig_hash | 2 +- 12 files changed, 983 insertions(+), 1954 deletions(-) diff --git a/src/belos/src/swig/forbelos.F90 b/src/belos/src/swig/forbelos.F90 index a48f9153..c6a37d2c 100644 --- a/src/belos/src/swig/forbelos.F90 +++ b/src/belos/src/swig/forbelos.F90 @@ -111,17 +111,13 @@ module forbelos bind(C, name="_wrap_BelosDebug") :: BelosDebug integer, parameter, public :: BelosMsgType = C_INT public :: convertMsgTypeToString - enum, bind(c) - enumerator :: SWIG_NULL - enumerator :: SWIG_OWN - enumerator :: SWIG_MOVE - enumerator :: SWIG_REF - enumerator :: SWIG_CREF - end enum - integer, parameter :: SwigMemState = kind(SWIG_NULL) + + integer, parameter :: swig_cmem_own_bit = 0 + integer, parameter :: swig_cmem_rvalue_bit = 1 + integer, parameter :: swig_cmem_const_bit = 2 type, bind(C) :: SwigClassWrapper type(C_PTR), public :: cptr = C_NULL_PTR - integer(C_INT), public :: mem = SWIG_NULL + integer(C_INT), public :: cmemflags = 0 end type real(C_DOUBLE), protected, public, & bind(C, name="_wrap_DefaultSolverParameters_convTol") :: DefaultSolverParameters_convTol @@ -137,12 +133,12 @@ module forbelos type, public :: DefaultSolverParameters type(SwigClassWrapper), public :: swigdata contains - procedure :: release => delete_DefaultSolverParameters + procedure :: release => swigf_release_DefaultSolverParameters procedure, private :: swigf_DefaultSolverParameters_op_assign__ generic :: assignment(=) => swigf_DefaultSolverParameters_op_assign__ end type DefaultSolverParameters interface DefaultSolverParameters - module procedure new_DefaultSolverParameters + module procedure swigf_create_DefaultSolverParameters end interface ! WRAPPER DECLARATIONS @@ -350,7 +346,7 @@ function convertMsgTypeToString(msgtype) & call SWIG_free(fresult%data) end function -function new_DefaultSolverParameters() & +function swigf_create_DefaultSolverParameters() & result(self) use, intrinsic :: ISO_C_BINDING type(DefaultSolverParameters) :: self @@ -360,17 +356,18 @@ function new_DefaultSolverParameters() & self%swigdata = fresult end function -subroutine delete_DefaultSolverParameters(self) +subroutine swigf_release_DefaultSolverParameters(self) use, intrinsic :: ISO_C_BINDING class(DefaultSolverParameters), intent(inout) :: self type(SwigClassWrapper) :: farg1 farg1 = self%swigdata -if (self%swigdata%mem == SWIG_OWN) then +if (btest(farg1%cmemflags, swig_cmem_own_bit)) then call swigc_delete_DefaultSolverParameters(farg1) -end if -self%swigdata%cptr = C_NULL_PTR -self%swigdata%mem = SWIG_NULL +endif +farg1%cptr = C_NULL_PTR +farg1%cmemflags = 0 +self%swigdata = farg1 end subroutine subroutine swigf_DefaultSolverParameters_op_assign__(self, other) diff --git a/src/belos/src/swig/forbelosFORTRAN_wrap.cxx b/src/belos/src/swig/forbelosFORTRAN_wrap.cxx index 635f0c2a..40032620 100644 --- a/src/belos/src/swig/forbelosFORTRAN_wrap.cxx +++ b/src/belos/src/swig/forbelosFORTRAN_wrap.cxx @@ -205,24 +205,31 @@ void SWIG_store_exception(const char* decl, int errcode, const char *msg); SWIG_store_exception(DECL, CODE, MSG); RETURNNULL; -namespace swig { - -enum AssignmentFlags { - IS_DESTR = 0x01, - IS_COPY_CONSTR = 0x02, - IS_COPY_ASSIGN = 0x04, - IS_MOVE_CONSTR = 0x08, - IS_MOVE_ASSIGN = 0x10 +enum SwigMemFlags { + SWIG_MEM_OWN = 0x01, + SWIG_MEM_RVALUE = 0x02, + SWIG_MEM_CONST = 0x04 }; -template -struct assignment_flags; -} + +#define SWIG_check_mutable(SWIG_CLASS_WRAPPER, TYPENAME, FNAME, FUNCNAME, RETURNNULL) \ + if ((SWIG_CLASS_WRAPPER).cmemflags & SWIG_MEM_CONST) { \ + SWIG_exception_impl(FUNCNAME, SWIG_TypeError, \ + "Cannot pass const " TYPENAME " (class " FNAME ") " \ + "as a mutable reference", \ + RETURNNULL); \ + } -#define SWIG_assign(LEFTTYPE, LEFT, RIGHTTYPE, RIGHT, FLAGS) \ - SWIG_assign_impl::value >(LEFT, RIGHT); +namespace swig { +enum AssignmentType { + ASSIGNMENT_DEFAULT, + ASSIGNMENT_NODESTRUCT, + ASSIGNMENT_SMARTPTR +}; +} +#define SWIGPOLICY_Belos__DefaultSolverParameters swig::ASSIGNMENT_DEFAULT #include @@ -278,258 +285,125 @@ SWIGINTERN SwigArrayWrapper SwigArrayWrapper_uninitialized() { #include -enum SwigMemState { - SWIG_NULL, - SWIG_OWN, - SWIG_MOVE, - SWIG_REF, - SWIG_CREF -}; - - struct SwigClassWrapper { void* cptr; - SwigMemState mem; + int cmemflags; }; SWIGINTERN SwigClassWrapper SwigClassWrapper_uninitialized() { SwigClassWrapper result; result.cptr = NULL; - result.mem = SWIG_NULL; + result.cmemflags = 0; return result; } -#include - - namespace swig { -// Define our own switching struct to support pre-c++11 builds -template -struct bool_constant {}; -typedef bool_constant true_type; -typedef bool_constant false_type; - -// Deletion -template -SWIGINTERN void destruct_impl(T* self, true_type) { - delete self; -} +template +struct DestructorPolicy { + static SwigClassWrapper destruct(SwigClassWrapper self) { + delete static_cast(self.cptr); + return SwigClassWrapper_uninitialized(); + } +}; template -SWIGINTERN T* destruct_impl(T* , false_type) { - SWIG_exception_impl("assignment", SWIG_TypeError, - "Invalid assignment: class type has no destructor", - return NULL); -} - -// Copy construction and assignment -template -SWIGINTERN T* copy_construct_impl(const U* other, true_type) { - return new T(*other); -} -template -SWIGINTERN void copy_assign_impl(T* self, const U* other, true_type) { - *self = *other; -} - -// Disabled construction and assignment -template -SWIGINTERN T* copy_construct_impl(const U* , false_type) { - SWIG_exception_impl("assignment", SWIG_TypeError, - "Invalid assignment: class type has no copy constructor", - return NULL); -} -template -SWIGINTERN void copy_assign_impl(T* , const U* , false_type) { - SWIG_exception_impl("assignment", SWIG_TypeError, - "Invalid assignment: class type has no copy assignment", - return); -} - -#if __cplusplus >= 201103L -#include -#include - -// Move construction and assignment -template -SWIGINTERN T* move_construct_impl(U* other, true_type) { - return new T(std::move(*other)); -} -template -SWIGINTERN void move_assign_impl(T* self, U* other, true_type) { - *self = std::move(*other); -} - -// Disabled move construction and assignment -template -SWIGINTERN T* move_construct_impl(U*, false_type) { - SWIG_exception_impl("assignment", SWIG_TypeError, - "Invalid assignment: class type has no move constructor", - return NULL); -} -template -SWIGINTERN void move_assign_impl(T*, U*, false_type) { - SWIG_exception_impl("assignment", SWIG_TypeError, - "Invalid assignment: class type has no move assignment", - return); -} - -template -struct assignment_flags { - constexpr static int value = - (std::is_destructible::value ? IS_DESTR : 0) - | (std::is_copy_constructible::value ? IS_COPY_CONSTR : 0) - | (std::is_copy_assignable::value ? IS_COPY_ASSIGN : 0) - | (std::is_move_constructible::value ? IS_MOVE_CONSTR : 0) - | (std::is_move_assignable::value ? IS_MOVE_ASSIGN : 0); +struct DestructorPolicy { + static SwigClassWrapper destruct(SwigClassWrapper self) { + SWIG_exception_impl("assignment", SWIG_TypeError, "Invalid assignment: class type has private destructor", return SwigClassWrapper_uninitialized()); + } }; +} -#else - -template -struct assignment_flags { - enum { value = Flags }; -}; -#endif +namespace swig { -template -struct AssignmentTraits { - static void destruct(T* self) { - destruct_impl(self, bool_constant()); +template +struct AssignmentPolicy { + static SwigClassWrapper destruct(SwigClassWrapper self) { + return DestructorPolicy::destruct(self); } - - template - static T* copy_construct(const U* other) { - return copy_construct_impl(other, bool_constant()); + static SwigClassWrapper alias(SwigClassWrapper other) { + SwigClassWrapper self; + self.cptr = other.cptr; + self.cmemflags = other.cmemflags & ~SWIG_MEM_OWN; + return self; } - - template - static void copy_assign(T* self, const U* other) { - copy_assign_impl(self, other, bool_constant()); + static SwigClassWrapper move_alias(SwigClassWrapper self, SwigClassWrapper other) { + if (self.cmemflags & SWIG_MEM_OWN) { + destruct(self); + } + self.cptr = other.cptr; + self.cmemflags = other.cmemflags & ~SWIG_MEM_RVALUE; + return self; + } + static SwigClassWrapper copy_alias(SwigClassWrapper self, SwigClassWrapper other) { + if (self.cmemflags & SWIG_MEM_OWN) { + destruct(self); + } + self.cptr = other.cptr; + self.cmemflags = other.cmemflags & ~SWIG_MEM_OWN; + return self; } +}; -#if __cplusplus >= 201103L - template - static T* move_construct(U* other) { - return move_construct_impl(other, bool_constant()); +template +struct AssignmentPolicy { + static SwigClassWrapper destruct(SwigClassWrapper self) { + return DestructorPolicy::destruct(self); } - template - static void move_assign(T* self, U* other) { - move_assign_impl(self, other, bool_constant()); + static SwigClassWrapper alias(SwigClassWrapper other) { + SwigClassWrapper self; + self.cptr = new T(*static_cast(other.cptr)); + self.cmemflags = other.cmemflags | SWIG_MEM_OWN; + return self; } -#else - template - static T* move_construct(U* other) { - return copy_construct_impl(other, bool_constant()); + static SwigClassWrapper move_alias(SwigClassWrapper self, SwigClassWrapper other) { + self = copy_alias(self, other); + self.cmemflags = other.cmemflags & ~SWIG_MEM_RVALUE; + destruct(other); + return self; } - template - static void move_assign(T* self, U* other) { - copy_assign_impl(self, other, bool_constant()); + static SwigClassWrapper copy_alias(SwigClassWrapper self, SwigClassWrapper other) { + // LHS and RHS should both 'own' their shared pointers + T *pself = static_cast(self.cptr); + T *pother = static_cast(other.cptr); + *pself = *pother; + return self; } -#endif }; } // end namespace swig - -template -SWIGINTERN void SWIG_assign_impl(SwigClassWrapper* self, const SwigClassWrapper* other) { - typedef swig::AssignmentTraits Traits_t; - T1* pself = static_cast(self->cptr); - T2* pother = static_cast(other->cptr); - - switch (self->mem) { - case SWIG_NULL: - /* LHS is unassigned */ - switch (other->mem) { - case SWIG_NULL: /* null op */ - break; - case SWIG_MOVE: /* capture pointer from RHS */ - self->cptr = other->cptr; - self->mem = SWIG_OWN; - break; - case SWIG_OWN: /* copy from RHS */ - self->cptr = Traits_t::copy_construct(pother); - self->mem = SWIG_OWN; - break; - case SWIG_REF: /* pointer to RHS */ - case SWIG_CREF: - self->cptr = other->cptr; - self->mem = other->mem; - break; - } - break; - case SWIG_OWN: - /* LHS owns memory */ - switch (other->mem) { - case SWIG_NULL: - /* Delete LHS */ - Traits_t::destruct(pself); - self->cptr = NULL; - self->mem = SWIG_NULL; - break; - case SWIG_MOVE: - /* Move RHS into LHS; delete RHS */ - Traits_t::move_assign(pself, pother); - Traits_t::destruct(pother); - break; - case SWIG_OWN: - case SWIG_REF: - case SWIG_CREF: - /* Copy RHS to LHS */ - Traits_t::copy_assign(pself, pother); - break; - } - break; - case SWIG_MOVE: - SWIG_exception_impl("assignment", SWIG_RuntimeError, - "Left-hand side of assignment should never be in a 'MOVE' state", - return); - break; - case SWIG_REF: - /* LHS is a reference */ - switch (other->mem) { - case SWIG_NULL: - /* Remove LHS reference */ - self->cptr = NULL; - self->mem = SWIG_NULL; - break; - case SWIG_MOVE: - /* Move RHS into LHS; delete RHS. The original ownership stays the - * same. */ - Traits_t::move_assign(pself, pother); - Traits_t::destruct(pother); - break; - case SWIG_OWN: - case SWIG_REF: - case SWIG_CREF: - /* Copy RHS to LHS */ - Traits_t::copy_assign(pself, pother); - break; - } - break; - case SWIG_CREF: - switch (other->mem) { - case SWIG_NULL: - /* Remove LHS reference */ - self->cptr = NULL; - self->mem = SWIG_NULL; - break; - default: - SWIG_exception_impl("assignment", SWIG_RuntimeError, - "Cannot assign to a const reference", return); - break; - } - break; +template +SWIGINTERN void SWIG_assign(SwigClassWrapper* self, SwigClassWrapper other) { + typedef swig::AssignmentPolicy Policy_t; + + if (self->cptr == NULL) { + /* LHS is unassigned */ + if (other.cmemflags & SWIG_MEM_RVALUE) { + /* Capture pointer from RHS, clear 'moving' flag */ + self->cptr = other.cptr; + self->cmemflags = other.cmemflags & (~SWIG_MEM_RVALUE); + } else { + /* Aliasing another class; clear ownership or copy smart pointer */ + *self = Policy_t::alias(other); + } + } else if (other.cptr == NULL) { + /* Replace LHS with a null pointer */ + *self = Policy_t::destruct(*self); + } else if (other.cmemflags & SWIG_MEM_RVALUE) { + /* Transferred ownership from a variable that's about to be lost. + * Move-assign and delete the transient data */ + *self = Policy_t::move_alias(*self, other); + } else { + /* RHS shouldn't be deleted, alias to LHS */ + *self = Policy_t::copy_alias(*self, other); } } -#ifdef __cplusplus extern "C" { -#endif SWIGEXPORT SwigArrayWrapper _wrap_convertReturnTypeToString(int const *farg1) { SwigArrayWrapper fresult ; Belos::ReturnType arg1 ; @@ -672,7 +546,7 @@ SWIGEXPORT SwigClassWrapper _wrap_new_DefaultSolverParameters() { result = (Belos::DefaultSolverParameters *)new Belos::DefaultSolverParameters(); fresult.cptr = result; - fresult.mem = (1 ? SWIG_MOVE : SWIG_REF); + fresult.cmemflags = SWIG_MEM_RVALUE | (1 ? SWIG_MEM_OWN : 0); return fresult; } @@ -680,7 +554,8 @@ SWIGEXPORT SwigClassWrapper _wrap_new_DefaultSolverParameters() { SWIGEXPORT void _wrap_delete_DefaultSolverParameters(SwigClassWrapper *farg1) { Belos::DefaultSolverParameters *arg1 = (Belos::DefaultSolverParameters *) 0 ; - (void)sizeof(farg1); + SWIG_check_mutable(*farg1, "Belos::DefaultSolverParameters *", "DefaultSolverParameters", "Belos::DefaultSolverParameters::~DefaultSolverParameters()", return ); + arg1 = static_cast< Belos::DefaultSolverParameters * >(farg1->cptr); delete arg1; } @@ -691,12 +566,10 @@ SWIGEXPORT void _wrap_DefaultSolverParameters_op_assign__(SwigClassWrapper *farg (void)sizeof(arg1); (void)sizeof(arg2); - typedef Belos::DefaultSolverParameters swig_lhs_classtype; - SWIG_assign(swig_lhs_classtype, farg1, swig_lhs_classtype, farg2, 0 | swig::IS_DESTR | swig::IS_COPY_CONSTR); + SWIG_assign(farg1, *farg2); + } -#ifdef __cplusplus -} -#endif +} // extern diff --git a/src/interface/src/nox.i b/src/interface/src/nox.i index 1cb62853..09906363 100644 --- a/src/interface/src/nox.i +++ b/src/interface/src/nox.i @@ -90,17 +90,17 @@ SwigClassWrapper swigd_ForModelEvaluator_create_operator( const_cast(this) SWIG_NO_NULL_DELETER_0); SwigClassWrapper self; self.cptr = &tempthis; - self.mem = SWIG_CREF; // since this function is const + self.cmemflags = SWIG_MEM_CONST; // since this function is const /* convert x -> class wrapper */ SwigClassWrapper farg1; farg1.cptr = const_cast*>(&x); - farg1.mem = SWIG_CREF; // x is const + farg1.cmemflags = SWIG_MEM_CONST; // x is const /* convert f -> class wrapper */ SwigClassWrapper farg2; farg2.cptr = &f; - farg2.mem = SWIG_REF; // f is mutable + farg2.cmemflags = 0; // f is mutable swigd_ForModelEvaluator_evaluate_residual(&self, &farg1, &farg2); } @@ -112,17 +112,17 @@ SwigClassWrapper swigd_ForModelEvaluator_create_operator( const_cast(this) SWIG_NO_NULL_DELETER_0); SwigClassWrapper self; self.cptr = &tempthis; - self.mem = SWIG_CREF; // since this function is const + self.cmemflags = SWIG_MEM_CONST; // since this function is const /* convert x -> class wrapper */ SwigClassWrapper farg1; farg1.cptr = const_cast*>(&x); - farg1.mem = SWIG_CREF; // x is const + farg1.cmemflags = SWIG_MEM_CONST; // x is const /* convert J -> class wrapper */ SwigClassWrapper farg2; farg2.cptr = &J; - farg2.mem = SWIG_REF; // f is mutable + farg2.cmemflags = 0; // f is mutable swigd_ForModelEvaluator_evaluate_jacobian(&self, &farg1, &farg2); } @@ -134,17 +134,17 @@ SwigClassWrapper swigd_ForModelEvaluator_create_operator( const_cast(this) SWIG_NO_NULL_DELETER_0); SwigClassWrapper self; self.cptr = &tempthis; - self.mem = SWIG_CREF; // since this function is const + self.cmemflags = SWIG_MEM_CONST; // since this function is const /* convert x -> class wrapper */ SwigClassWrapper farg1; farg1.cptr = const_cast*>(&x); - farg1.mem = SWIG_CREF; // x is const + farg1.cmemflags = SWIG_MEM_CONST; // x is const /* convert M -> class wrapper */ SwigClassWrapper farg2; farg2.cptr = &M; - farg2.mem = SWIG_REF; // f is mutable + farg2.cmemflags = 0; // f is mutable swigd_ForModelEvaluator_evaluate_preconditioner(&self, &farg1, &farg2); } @@ -155,7 +155,7 @@ SwigClassWrapper swigd_ForModelEvaluator_create_operator( const_cast(this) SWIG_NO_NULL_DELETER_0); SwigClassWrapper self; self.cptr = &tempthis; - self.mem = SWIG_CREF; // since this function is const + self.cmemflags = SWIG_MEM_CONST; // since this function is const SwigClassWrapper fresult = swigd_ForModelEvaluator_get_x_map(&self); @@ -169,7 +169,7 @@ SwigClassWrapper swigd_ForModelEvaluator_create_operator( const_cast(this) SWIG_NO_NULL_DELETER_0); SwigClassWrapper self; self.cptr = &tempthis; - self.mem = SWIG_CREF; // since this function is const + self.cmemflags = SWIG_MEM_CONST; // since this function is const SwigClassWrapper fresult = swigd_ForModelEvaluator_get_f_map(&self); @@ -183,7 +183,7 @@ SwigClassWrapper swigd_ForModelEvaluator_create_operator( const_cast(this) SWIG_NO_NULL_DELETER_0); SwigClassWrapper self; self.cptr = &tempthis; - self.mem = SWIG_CREF; // since this function is const + self.cmemflags = SWIG_MEM_CONST; // since this function is const SwigClassWrapper fresult = swigd_ForModelEvaluator_create_operator(&self); diff --git a/src/interface/src/swig/fortrilinos.F90 b/src/interface/src/swig/fortrilinos.F90 index 3126fa87..0e42122c 100644 --- a/src/interface/src/swig/fortrilinos.F90 +++ b/src/interface/src/swig/fortrilinos.F90 @@ -18,23 +18,18 @@ module fortrilinos private ! DECLARATION CONSTRUCTS - enum, bind(c) - enumerator :: SWIG_NULL - enumerator :: SWIG_OWN - enumerator :: SWIG_MOVE - enumerator :: SWIG_REF - enumerator :: SWIG_CREF - end enum - integer, parameter :: SwigMemState = kind(SWIG_NULL) + + integer, parameter :: swig_cmem_own_bit = 0 + integer, parameter :: swig_cmem_rvalue_bit = 1 + integer, parameter :: swig_cmem_const_bit = 2 type, bind(C) :: SwigClassWrapper type(C_PTR), public :: cptr = C_NULL_PTR - integer(C_INT), public :: mem = SWIG_NULL + integer(C_INT), public :: cmemflags = 0 end type ! class ForTrilinos::TrilinosSolver type, public :: TrilinosSolver type(SwigClassWrapper), public :: swigdata contains - procedure, private :: swigf_TrilinosSolver_op_assign__ procedure, private :: swigf_TrilinosSolver_init__SWIG_0 procedure, private :: swigf_TrilinosSolver_init__SWIG_1 procedure :: setup_matrix => swigf_TrilinosSolver_setup_matrix @@ -42,12 +37,13 @@ module fortrilinos procedure :: setup_solver => swigf_TrilinosSolver_setup_solver procedure :: solve => swigf_TrilinosSolver_solve procedure :: finalize => swigf_TrilinosSolver_finalize - procedure :: release => delete_TrilinosSolver - generic :: assignment(=) => swigf_TrilinosSolver_op_assign__ + procedure :: release => swigf_release_TrilinosSolver + procedure, private :: swigf_TrilinosSolver_op_assign__ generic :: init => swigf_TrilinosSolver_init__SWIG_0, swigf_TrilinosSolver_init__SWIG_1 + generic :: assignment(=) => swigf_TrilinosSolver_op_assign__ end type TrilinosSolver interface TrilinosSolver - module procedure new_TrilinosSolver + module procedure swigf_create_TrilinosSolver end interface type, bind(C) :: SwigArrayWrapper type(C_PTR), public :: data = C_NULL_PTR @@ -57,7 +53,6 @@ module fortrilinos type, public :: TrilinosEigenSolver type(SwigClassWrapper), public :: swigdata contains - procedure, private :: swigf_TrilinosEigenSolver_op_assign__ procedure, private :: swigf_TrilinosEigenSolver_init__SWIG_0 procedure, private :: swigf_TrilinosEigenSolver_init__SWIG_1 procedure :: setup_matrix => swigf_TrilinosEigenSolver_setup_matrix @@ -67,16 +62,14 @@ module fortrilinos procedure :: setup_solver => swigf_TrilinosEigenSolver_setup_solver procedure :: solve => swigf_TrilinosEigenSolver_solve procedure :: finalize => swigf_TrilinosEigenSolver_finalize - procedure :: release => delete_TrilinosEigenSolver - generic :: assignment(=) => swigf_TrilinosEigenSolver_op_assign__ + procedure :: release => swigf_release_TrilinosEigenSolver + procedure, private :: swigf_TrilinosEigenSolver_op_assign__ generic :: init => swigf_TrilinosEigenSolver_init__SWIG_0, swigf_TrilinosEigenSolver_init__SWIG_1 + generic :: assignment(=) => swigf_TrilinosEigenSolver_op_assign__ end type TrilinosEigenSolver interface TrilinosEigenSolver - module procedure new_TrilinosEigenSolver + module procedure swigf_create_TrilinosEigenSolver end interface - type, public :: SWIGTYPE_ForTrilinos__ModelEvaluatorT_SC_LO_GO_NO_t - type(SwigClassWrapper), public :: swigdata - end type ! class ForTrilinos::ModelEvaluator< SC,LO,GO,NO > type, public :: ForTrilinosModelEvaluator type(SwigClassWrapper), public :: swigdata @@ -88,7 +81,7 @@ module fortrilinos procedure :: get_f_map => swigf_ForTrilinosModelEvaluator_get_f_map procedure :: create_operator => swigf_ForTrilinosModelEvaluator_create_operator procedure :: setup => swigf_ForTrilinosModelEvaluator_setup - procedure :: release => delete_ForTrilinosModelEvaluator + procedure :: release => swigf_release_ForTrilinosModelEvaluator procedure, private :: swigf_ForTrilinosModelEvaluator_op_assign__ generic :: assignment(=) => swigf_ForTrilinosModelEvaluator_op_assign__ end type ForTrilinosModelEvaluator @@ -104,12 +97,12 @@ module fortrilinos procedure :: get_x_map => swigf_ForModelEvaluator_get_x_map procedure :: get_f_map => swigf_ForModelEvaluator_get_f_map procedure :: create_operator => swigf_ForModelEvaluator_create_operator - procedure :: release => delete_ForModelEvaluator + procedure :: release => swigf_release_ForModelEvaluator procedure, private :: swigf_ForModelEvaluator_op_assign__ generic :: assignment(=) => swigf_ForModelEvaluator_op_assign__ end type ForModelEvaluator interface ForModelEvaluator - module procedure new_ForModelEvaluator + module procedure swigf_create_ForModelEvaluator end interface type :: ForModelEvaluatorHandle @@ -120,21 +113,18 @@ module fortrilinos public :: init_ForModelEvaluator integer, parameter, public :: SWIGTYPE_NOX__StatusTest__StatusType = C_INT - type, public :: SWIGTYPE_ForTrilinos__NOXSolverT_SC_LO_GO_NO_t - type(SwigClassWrapper), public :: swigdata - end type ! class ForTrilinos::NOXSolver< SC,LO,GO,NO > type, public :: NOXSolver type(SwigClassWrapper), public :: swigdata contains procedure :: setup => swigf_NOXSolver_setup procedure :: solve => swigf_NOXSolver_solve - procedure :: release => delete_NOXSolver + procedure :: release => swigf_release_NOXSolver procedure, private :: swigf_NOXSolver_op_assign__ generic :: assignment(=) => swigf_NOXSolver_op_assign__ end type NOXSolver interface NOXSolver - module procedure new_NOXSolver + module procedure swigf_create_NOXSolver end interface ! enum NOX::StatusTest::StatusType enum, bind(c) @@ -164,14 +154,6 @@ function swigc_new_TrilinosSolver() & type(SwigClassWrapper) :: fresult end function -subroutine swigc_TrilinosSolver_op_assign__(farg1, farg2) & -bind(C, name="_wrap_TrilinosSolver_op_assign__") -use, intrinsic :: ISO_C_BINDING -import :: swigclasswrapper -type(SwigClassWrapper), intent(inout) :: farg1 -type(SwigClassWrapper) :: farg2 -end subroutine - subroutine swigc_TrilinosSolver_init__SWIG_0(farg1) & bind(C, name="_wrap_TrilinosSolver_init__SWIG_0") use, intrinsic :: ISO_C_BINDING @@ -234,6 +216,14 @@ subroutine swigc_delete_TrilinosSolver(farg1) & type(SwigClassWrapper), intent(inout) :: farg1 end subroutine +subroutine swigc_TrilinosSolver_op_assign__(farg1, farg2) & +bind(C, name="_wrap_TrilinosSolver_op_assign__") +use, intrinsic :: ISO_C_BINDING +import :: swigclasswrapper +type(SwigClassWrapper), intent(inout) :: farg1 +type(SwigClassWrapper) :: farg2 +end subroutine + function swigc_new_TrilinosEigenSolver() & bind(C, name="_wrap_new_TrilinosEigenSolver") & result(fresult) @@ -242,14 +232,6 @@ function swigc_new_TrilinosEigenSolver() & type(SwigClassWrapper) :: fresult end function -subroutine swigc_TrilinosEigenSolver_op_assign__(farg1, farg2) & -bind(C, name="_wrap_TrilinosEigenSolver_op_assign__") -use, intrinsic :: ISO_C_BINDING -import :: swigclasswrapper -type(SwigClassWrapper), intent(inout) :: farg1 -type(SwigClassWrapper) :: farg2 -end subroutine - subroutine swigc_TrilinosEigenSolver_init__SWIG_0(farg1) & bind(C, name="_wrap_TrilinosEigenSolver_init__SWIG_0") use, intrinsic :: ISO_C_BINDING @@ -332,6 +314,14 @@ subroutine swigc_delete_TrilinosEigenSolver(farg1) & type(SwigClassWrapper), intent(inout) :: farg1 end subroutine +subroutine swigc_TrilinosEigenSolver_op_assign__(farg1, farg2) & +bind(C, name="_wrap_TrilinosEigenSolver_op_assign__") +use, intrinsic :: ISO_C_BINDING +import :: swigclasswrapper +type(SwigClassWrapper), intent(inout) :: farg1 +type(SwigClassWrapper) :: farg2 +end subroutine + subroutine swigc_ForTrilinosModelEvaluator_evaluate_residual(farg1, farg2, farg3) & bind(C, name="_wrap_ForTrilinosModelEvaluator_evaluate_residual") use, intrinsic :: ISO_C_BINDING @@ -557,7 +547,7 @@ subroutine swigc_NOXSolver_op_assign__(farg1, farg2) & contains ! MODULE SUBPROGRAMS -function new_TrilinosSolver() & +function swigf_create_TrilinosSolver() & result(self) use, intrinsic :: ISO_C_BINDING type(TrilinosSolver) :: self @@ -567,19 +557,6 @@ function new_TrilinosSolver() & self%swigdata = fresult end function -subroutine swigf_TrilinosSolver_op_assign__(self, other) -use, intrinsic :: ISO_C_BINDING -class(TrilinosSolver), intent(inout) :: self -type(TrilinosSolver), intent(in) :: other -type(SwigClassWrapper) :: farg1 -type(SwigClassWrapper) :: farg2 - -farg1 = self%swigdata -farg2 = other%swigdata -call swigc_TrilinosSolver_op_assign__(farg1, farg2) -self%swigdata = farg1 -end subroutine - subroutine swigf_TrilinosSolver_init__SWIG_0(self) use, intrinsic :: ISO_C_BINDING class(TrilinosSolver), intent(in) :: self @@ -661,42 +638,43 @@ subroutine swigf_TrilinosSolver_finalize(self) call swigc_TrilinosSolver_finalize(farg1) end subroutine -subroutine delete_TrilinosSolver(self) +subroutine swigf_release_TrilinosSolver(self) use, intrinsic :: ISO_C_BINDING class(TrilinosSolver), intent(inout) :: self type(SwigClassWrapper) :: farg1 farg1 = self%swigdata -if (self%swigdata%mem == SWIG_OWN) then +if (btest(farg1%cmemflags, swig_cmem_own_bit)) then call swigc_delete_TrilinosSolver(farg1) -end if -self%swigdata%cptr = C_NULL_PTR -self%swigdata%mem = SWIG_NULL +endif +farg1%cptr = C_NULL_PTR +farg1%cmemflags = 0 +self%swigdata = farg1 end subroutine -function new_TrilinosEigenSolver() & -result(self) -use, intrinsic :: ISO_C_BINDING -type(TrilinosEigenSolver) :: self -type(SwigClassWrapper) :: fresult - -fresult = swigc_new_TrilinosEigenSolver() -self%swigdata = fresult -end function - -subroutine swigf_TrilinosEigenSolver_op_assign__(self, other) +subroutine swigf_TrilinosSolver_op_assign__(self, other) use, intrinsic :: ISO_C_BINDING -class(TrilinosEigenSolver), intent(inout) :: self -type(TrilinosEigenSolver), intent(in) :: other +class(TrilinosSolver), intent(inout) :: self +type(TrilinosSolver), intent(in) :: other type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 farg1 = self%swigdata farg2 = other%swigdata -call swigc_TrilinosEigenSolver_op_assign__(farg1, farg2) +call swigc_TrilinosSolver_op_assign__(farg1, farg2) self%swigdata = farg1 end subroutine +function swigf_create_TrilinosEigenSolver() & +result(self) +use, intrinsic :: ISO_C_BINDING +type(TrilinosEigenSolver) :: self +type(SwigClassWrapper) :: fresult + +fresult = swigc_new_TrilinosEigenSolver() +self%swigdata = fresult +end function + subroutine swigf_TrilinosEigenSolver_init__SWIG_0(self) use, intrinsic :: ISO_C_BINDING class(TrilinosEigenSolver), intent(in) :: self @@ -825,17 +803,31 @@ subroutine swigf_TrilinosEigenSolver_finalize(self) call swigc_TrilinosEigenSolver_finalize(farg1) end subroutine -subroutine delete_TrilinosEigenSolver(self) +subroutine swigf_release_TrilinosEigenSolver(self) use, intrinsic :: ISO_C_BINDING class(TrilinosEigenSolver), intent(inout) :: self type(SwigClassWrapper) :: farg1 farg1 = self%swigdata -if (self%swigdata%mem == SWIG_OWN) then +if (btest(farg1%cmemflags, swig_cmem_own_bit)) then call swigc_delete_TrilinosEigenSolver(farg1) -end if -self%swigdata%cptr = C_NULL_PTR -self%swigdata%mem = SWIG_NULL +endif +farg1%cptr = C_NULL_PTR +farg1%cmemflags = 0 +self%swigdata = farg1 +end subroutine + +subroutine swigf_TrilinosEigenSolver_op_assign__(self, other) +use, intrinsic :: ISO_C_BINDING +class(TrilinosEigenSolver), intent(inout) :: self +type(TrilinosEigenSolver), intent(in) :: other +type(SwigClassWrapper) :: farg1 +type(SwigClassWrapper) :: farg2 + +farg1 = self%swigdata +farg2 = other%swigdata +call swigc_TrilinosEigenSolver_op_assign__(farg1, farg2) +self%swigdata = farg1 end subroutine subroutine swigf_ForTrilinosModelEvaluator_evaluate_residual(self, x, f) @@ -934,23 +926,24 @@ subroutine swigf_ForTrilinosModelEvaluator_setup(self, plist) call swigc_ForTrilinosModelEvaluator_setup(farg1, farg2) end subroutine -subroutine delete_ForTrilinosModelEvaluator(self) +subroutine swigf_release_ForTrilinosModelEvaluator(self) use, intrinsic :: ISO_C_BINDING class(ForTrilinosModelEvaluator), intent(inout) :: self type(SwigClassWrapper) :: farg1 farg1 = self%swigdata -if (self%swigdata%mem == SWIG_OWN) then +if (btest(farg1%cmemflags, swig_cmem_own_bit)) then call swigc_delete_ForTrilinosModelEvaluator(farg1) -end if -self%swigdata%cptr = C_NULL_PTR -self%swigdata%mem = SWIG_NULL +endif +farg1%cptr = C_NULL_PTR +farg1%cmemflags = 0 +self%swigdata = farg1 end subroutine subroutine swigf_ForTrilinosModelEvaluator_op_assign__(self, other) use, intrinsic :: ISO_C_BINDING class(ForTrilinosModelEvaluator), intent(inout) :: self -type(SWIGTYPE_ForTrilinos__ModelEvaluatorT_SC_LO_GO_NO_t), intent(in) :: other +type(ForTrilinosModelEvaluator), intent(in) :: other type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 @@ -1081,7 +1074,7 @@ function swigf_ForModelEvaluator_create_operator(self) & swig_result%swigdata = fresult end function -function new_ForModelEvaluator() & +function swigf_create_ForModelEvaluator() & result(self) use, intrinsic :: ISO_C_BINDING type(ForModelEvaluator) :: self @@ -1091,7 +1084,7 @@ function new_ForModelEvaluator() & self%swigdata = fresult end function -subroutine delete_ForModelEvaluator(self) +subroutine swigf_release_ForModelEvaluator(self) use, intrinsic :: ISO_C_BINDING class(ForModelEvaluator), intent(inout) :: self type(SwigClassWrapper) :: farg1 @@ -1102,11 +1095,12 @@ subroutine delete_ForModelEvaluator(self) fself_ptr = swigc_ForModelEvaluator_fhandle(self%swigdata) call c_f_pointer(cptr=fself_ptr, fptr=handle) farg1 = self%swigdata -if (self%swigdata%mem == SWIG_OWN) then +if (btest(farg1%cmemflags, swig_cmem_own_bit)) then call swigc_delete_ForModelEvaluator(farg1) -end if -self%swigdata%cptr = C_NULL_PTR -self%swigdata%mem = SWIG_NULL +endif +farg1%cptr = C_NULL_PTR +farg1%cmemflags = 0 +self%swigdata = farg1 ! Release the allocated handle deallocate(handle) @@ -1290,7 +1284,7 @@ subroutine init_ForModelEvaluator(self) call swigc_ForModelEvaluator_init(self%swigdata, c_loc(handle)) end subroutine -function new_NOXSolver(model) & +function swigf_create_NOXSolver(model) & result(self) use, intrinsic :: ISO_C_BINDING type(NOXSolver) :: self @@ -1328,23 +1322,24 @@ function swigf_NOXSolver_solve(self) & swig_result = fresult end function -subroutine delete_NOXSolver(self) +subroutine swigf_release_NOXSolver(self) use, intrinsic :: ISO_C_BINDING class(NOXSolver), intent(inout) :: self type(SwigClassWrapper) :: farg1 farg1 = self%swigdata -if (self%swigdata%mem == SWIG_OWN) then +if (btest(farg1%cmemflags, swig_cmem_own_bit)) then call swigc_delete_NOXSolver(farg1) -end if -self%swigdata%cptr = C_NULL_PTR -self%swigdata%mem = SWIG_NULL +endif +farg1%cptr = C_NULL_PTR +farg1%cmemflags = 0 +self%swigdata = farg1 end subroutine subroutine swigf_NOXSolver_op_assign__(self, other) use, intrinsic :: ISO_C_BINDING class(NOXSolver), intent(inout) :: self -type(SWIGTYPE_ForTrilinos__NOXSolverT_SC_LO_GO_NO_t), intent(in) :: other +type(NOXSolver), intent(in) :: other type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 diff --git a/src/interface/src/swig/fortrilinosFORTRAN_wrap.cxx b/src/interface/src/swig/fortrilinosFORTRAN_wrap.cxx index 824dcc34..c1c170d4 100644 --- a/src/interface/src/swig/fortrilinosFORTRAN_wrap.cxx +++ b/src/interface/src/swig/fortrilinosFORTRAN_wrap.cxx @@ -205,27 +205,15 @@ void SWIG_store_exception(const char* decl, int errcode, const char *msg); SWIG_store_exception(DECL, CODE, MSG); RETURNNULL; -namespace swig { - -enum AssignmentFlags { - IS_DESTR = 0x01, - IS_COPY_CONSTR = 0x02, - IS_COPY_ASSIGN = 0x04, - IS_MOVE_CONSTR = 0x08, - IS_MOVE_ASSIGN = 0x10 +enum SwigMemFlags { + SWIG_MEM_OWN = 0x01, + SWIG_MEM_RVALUE = 0x02, + SWIG_MEM_CONST = 0x04 }; -template -struct assignment_flags; -} - - -#define SWIG_assign(LEFTTYPE, LEFT, RIGHTTYPE, RIGHT, FLAGS) \ - SWIG_assign_impl::value >(LEFT, RIGHT); - #define SWIG_check_mutable(SWIG_CLASS_WRAPPER, TYPENAME, FNAME, FUNCNAME, RETURNNULL) \ - if ((SWIG_CLASS_WRAPPER).mem == SWIG_CREF) { \ + if ((SWIG_CLASS_WRAPPER).cmemflags & SWIG_MEM_CONST) { \ SWIG_exception_impl(FUNCNAME, SWIG_TypeError, \ "Cannot pass const " TYPENAME " (class " FNAME ") " \ "as a mutable reference", \ @@ -234,7 +222,7 @@ struct assignment_flags; #define SWIG_check_nonnull(SWIG_CLASS_WRAPPER, TYPENAME, FNAME, FUNCNAME, RETURNNULL) \ - if ((SWIG_CLASS_WRAPPER).mem == SWIG_NULL) { \ + if (!(SWIG_CLASS_WRAPPER).cptr) { \ SWIG_exception_impl(FUNCNAME, SWIG_TypeError, \ "Cannot pass null " TYPENAME " (class " FNAME ") " \ "as a reference", RETURNNULL); \ @@ -246,6 +234,15 @@ struct assignment_flags; SWIG_check_mutable(SWIG_CLASS_WRAPPER, TYPENAME, FNAME, FUNCNAME, RETURNNULL); +namespace swig { +enum AssignmentType { + ASSIGNMENT_DEFAULT, + ASSIGNMENT_NODESTRUCT, + ASSIGNMENT_SMARTPTR +}; +} + + #define SWIG_check_sp_nonnull(INPUT, TYPENAME, FNAME, FUNCNAME, RETURNNULL) \ if (!(INPUT)) { \ SWIG_exception_impl(FUNCNAME, SWIG_TypeError, \ @@ -253,6 +250,15 @@ struct assignment_flags; "as a reference", RETURNNULL); \ } +#define SWIG_constsp_mem_flags SWIG_MEM_CONST +#define SWIG_sp_mem_flags 0 + + +#define SWIGPOLICY_ForTrilinos__TrilinosSolver swig::ASSIGNMENT_DEFAULT +#define SWIGPOLICY_ForTrilinos__TrilinosEigenSolver swig::ASSIGNMENT_DEFAULT +#define SWIGPOLICY_ForTrilinos__ModelEvaluatorT_double_int_long_long_Kokkos__Compat__KokkosSerialWrapperNode_t swig::ASSIGNMENT_SMARTPTR +#define SWIGPOLICY_ForModelEvaluator swig::ASSIGNMENT_SMARTPTR +#define SWIGPOLICY_ForTrilinos__NOXSolverT_double_int_long_long_Kokkos__Compat__KokkosSerialWrapperNode_t swig::ASSIGNMENT_SMARTPTR #include @@ -287,252 +293,121 @@ typedef char Packet; #include "eigen_handle.hpp" -enum SwigMemState { - SWIG_NULL, - SWIG_OWN, - SWIG_MOVE, - SWIG_REF, - SWIG_CREF -}; - - struct SwigClassWrapper { void* cptr; - SwigMemState mem; + int cmemflags; }; SWIGINTERN SwigClassWrapper SwigClassWrapper_uninitialized() { SwigClassWrapper result; result.cptr = NULL; - result.mem = SWIG_NULL; + result.cmemflags = 0; return result; } -#include - - namespace swig { -// Define our own switching struct to support pre-c++11 builds -template -struct bool_constant {}; -typedef bool_constant true_type; -typedef bool_constant false_type; - -// Deletion -template -SWIGINTERN void destruct_impl(T* self, true_type) { - delete self; -} +template +struct DestructorPolicy { + static SwigClassWrapper destruct(SwigClassWrapper self) { + delete static_cast(self.cptr); + return SwigClassWrapper_uninitialized(); + } +}; template -SWIGINTERN T* destruct_impl(T* , false_type) { - SWIG_exception_impl("assignment", SWIG_TypeError, - "Invalid assignment: class type has no destructor", - return NULL); -} - -// Copy construction and assignment -template -SWIGINTERN T* copy_construct_impl(const U* other, true_type) { - return new T(*other); -} -template -SWIGINTERN void copy_assign_impl(T* self, const U* other, true_type) { - *self = *other; -} - -// Disabled construction and assignment -template -SWIGINTERN T* copy_construct_impl(const U* , false_type) { - SWIG_exception_impl("assignment", SWIG_TypeError, - "Invalid assignment: class type has no copy constructor", - return NULL); -} -template -SWIGINTERN void copy_assign_impl(T* , const U* , false_type) { - SWIG_exception_impl("assignment", SWIG_TypeError, - "Invalid assignment: class type has no copy assignment", - return); -} - -#if __cplusplus >= 201103L -#include -#include - -// Move construction and assignment -template -SWIGINTERN T* move_construct_impl(U* other, true_type) { - return new T(std::move(*other)); -} -template -SWIGINTERN void move_assign_impl(T* self, U* other, true_type) { - *self = std::move(*other); -} - -// Disabled move construction and assignment -template -SWIGINTERN T* move_construct_impl(U*, false_type) { - SWIG_exception_impl("assignment", SWIG_TypeError, - "Invalid assignment: class type has no move constructor", - return NULL); -} -template -SWIGINTERN void move_assign_impl(T*, U*, false_type) { - SWIG_exception_impl("assignment", SWIG_TypeError, - "Invalid assignment: class type has no move assignment", - return); -} - -template -struct assignment_flags { - constexpr static int value = - (std::is_destructible::value ? IS_DESTR : 0) - | (std::is_copy_constructible::value ? IS_COPY_CONSTR : 0) - | (std::is_copy_assignable::value ? IS_COPY_ASSIGN : 0) - | (std::is_move_constructible::value ? IS_MOVE_CONSTR : 0) - | (std::is_move_assignable::value ? IS_MOVE_ASSIGN : 0); +struct DestructorPolicy { + static SwigClassWrapper destruct(SwigClassWrapper self) { + SWIG_exception_impl("assignment", SWIG_TypeError, "Invalid assignment: class type has private destructor", return SwigClassWrapper_uninitialized()); + } }; +} -#else - -template -struct assignment_flags { - enum { value = Flags }; -}; -#endif +namespace swig { -template -struct AssignmentTraits { - static void destruct(T* self) { - destruct_impl(self, bool_constant()); +template +struct AssignmentPolicy { + static SwigClassWrapper destruct(SwigClassWrapper self) { + return DestructorPolicy::destruct(self); } - - template - static T* copy_construct(const U* other) { - return copy_construct_impl(other, bool_constant()); + static SwigClassWrapper alias(SwigClassWrapper other) { + SwigClassWrapper self; + self.cptr = other.cptr; + self.cmemflags = other.cmemflags & ~SWIG_MEM_OWN; + return self; } - - template - static void copy_assign(T* self, const U* other) { - copy_assign_impl(self, other, bool_constant()); + static SwigClassWrapper move_alias(SwigClassWrapper self, SwigClassWrapper other) { + if (self.cmemflags & SWIG_MEM_OWN) { + destruct(self); + } + self.cptr = other.cptr; + self.cmemflags = other.cmemflags & ~SWIG_MEM_RVALUE; + return self; + } + static SwigClassWrapper copy_alias(SwigClassWrapper self, SwigClassWrapper other) { + if (self.cmemflags & SWIG_MEM_OWN) { + destruct(self); + } + self.cptr = other.cptr; + self.cmemflags = other.cmemflags & ~SWIG_MEM_OWN; + return self; } +}; -#if __cplusplus >= 201103L - template - static T* move_construct(U* other) { - return move_construct_impl(other, bool_constant()); +template +struct AssignmentPolicy { + static SwigClassWrapper destruct(SwigClassWrapper self) { + return DestructorPolicy::destruct(self); } - template - static void move_assign(T* self, U* other) { - move_assign_impl(self, other, bool_constant()); + static SwigClassWrapper alias(SwigClassWrapper other) { + SwigClassWrapper self; + self.cptr = new T(*static_cast(other.cptr)); + self.cmemflags = other.cmemflags | SWIG_MEM_OWN; + return self; } -#else - template - static T* move_construct(U* other) { - return copy_construct_impl(other, bool_constant()); + static SwigClassWrapper move_alias(SwigClassWrapper self, SwigClassWrapper other) { + self = copy_alias(self, other); + self.cmemflags = other.cmemflags & ~SWIG_MEM_RVALUE; + destruct(other); + return self; } - template - static void move_assign(T* self, U* other) { - copy_assign_impl(self, other, bool_constant()); + static SwigClassWrapper copy_alias(SwigClassWrapper self, SwigClassWrapper other) { + // LHS and RHS should both 'own' their shared pointers + T *pself = static_cast(self.cptr); + T *pother = static_cast(other.cptr); + *pself = *pother; + return self; } -#endif }; } // end namespace swig - -template -SWIGINTERN void SWIG_assign_impl(SwigClassWrapper* self, const SwigClassWrapper* other) { - typedef swig::AssignmentTraits Traits_t; - T1* pself = static_cast(self->cptr); - T2* pother = static_cast(other->cptr); - - switch (self->mem) { - case SWIG_NULL: - /* LHS is unassigned */ - switch (other->mem) { - case SWIG_NULL: /* null op */ - break; - case SWIG_MOVE: /* capture pointer from RHS */ - self->cptr = other->cptr; - self->mem = SWIG_OWN; - break; - case SWIG_OWN: /* copy from RHS */ - self->cptr = Traits_t::copy_construct(pother); - self->mem = SWIG_OWN; - break; - case SWIG_REF: /* pointer to RHS */ - case SWIG_CREF: - self->cptr = other->cptr; - self->mem = other->mem; - break; - } - break; - case SWIG_OWN: - /* LHS owns memory */ - switch (other->mem) { - case SWIG_NULL: - /* Delete LHS */ - Traits_t::destruct(pself); - self->cptr = NULL; - self->mem = SWIG_NULL; - break; - case SWIG_MOVE: - /* Move RHS into LHS; delete RHS */ - Traits_t::move_assign(pself, pother); - Traits_t::destruct(pother); - break; - case SWIG_OWN: - case SWIG_REF: - case SWIG_CREF: - /* Copy RHS to LHS */ - Traits_t::copy_assign(pself, pother); - break; - } - break; - case SWIG_MOVE: - SWIG_exception_impl("assignment", SWIG_RuntimeError, - "Left-hand side of assignment should never be in a 'MOVE' state", - return); - break; - case SWIG_REF: - /* LHS is a reference */ - switch (other->mem) { - case SWIG_NULL: - /* Remove LHS reference */ - self->cptr = NULL; - self->mem = SWIG_NULL; - break; - case SWIG_MOVE: - /* Move RHS into LHS; delete RHS. The original ownership stays the - * same. */ - Traits_t::move_assign(pself, pother); - Traits_t::destruct(pother); - break; - case SWIG_OWN: - case SWIG_REF: - case SWIG_CREF: - /* Copy RHS to LHS */ - Traits_t::copy_assign(pself, pother); - break; - } - break; - case SWIG_CREF: - switch (other->mem) { - case SWIG_NULL: - /* Remove LHS reference */ - self->cptr = NULL; - self->mem = SWIG_NULL; - break; - default: - SWIG_exception_impl("assignment", SWIG_RuntimeError, - "Cannot assign to a const reference", return); - break; - } - break; +template +SWIGINTERN void SWIG_assign(SwigClassWrapper* self, SwigClassWrapper other) { + typedef swig::AssignmentPolicy Policy_t; + + if (self->cptr == NULL) { + /* LHS is unassigned */ + if (other.cmemflags & SWIG_MEM_RVALUE) { + /* Capture pointer from RHS, clear 'moving' flag */ + self->cptr = other.cptr; + self->cmemflags = other.cmemflags & (~SWIG_MEM_RVALUE); + } else { + /* Aliasing another class; clear ownership or copy smart pointer */ + *self = Policy_t::alias(other); + } + } else if (other.cptr == NULL) { + /* Replace LHS with a null pointer */ + *self = Policy_t::destruct(*self); + } else if (other.cmemflags & SWIG_MEM_RVALUE) { + /* Transferred ownership from a variable that's about to be lost. + * Move-assign and delete the transient data */ + *self = Policy_t::move_alias(*self, other); + } else { + /* RHS shouldn't be deleted, alias to LHS */ + *self = Policy_t::copy_alias(*self, other); } } @@ -620,17 +495,17 @@ SwigClassWrapper swigd_ForModelEvaluator_create_operator( const_cast(this) SWIG_NO_NULL_DELETER_0); SwigClassWrapper self; self.cptr = &tempthis; - self.mem = SWIG_CREF; // since this function is const + self.cmemflags = SWIG_MEM_CONST; // since this function is const /* convert x -> class wrapper */ SwigClassWrapper farg1; farg1.cptr = const_cast*>(&x); - farg1.mem = SWIG_CREF; // x is const + farg1.cmemflags = SWIG_MEM_CONST; // x is const /* convert f -> class wrapper */ SwigClassWrapper farg2; farg2.cptr = &f; - farg2.mem = SWIG_REF; // f is mutable + farg2.cmemflags = 0; // f is mutable swigd_ForModelEvaluator_evaluate_residual(&self, &farg1, &farg2); } @@ -642,17 +517,17 @@ SwigClassWrapper swigd_ForModelEvaluator_create_operator( const_cast(this) SWIG_NO_NULL_DELETER_0); SwigClassWrapper self; self.cptr = &tempthis; - self.mem = SWIG_CREF; // since this function is const + self.cmemflags = SWIG_MEM_CONST; // since this function is const /* convert x -> class wrapper */ SwigClassWrapper farg1; farg1.cptr = const_cast*>(&x); - farg1.mem = SWIG_CREF; // x is const + farg1.cmemflags = SWIG_MEM_CONST; // x is const /* convert J -> class wrapper */ SwigClassWrapper farg2; farg2.cptr = &J; - farg2.mem = SWIG_REF; // f is mutable + farg2.cmemflags = 0; // f is mutable swigd_ForModelEvaluator_evaluate_jacobian(&self, &farg1, &farg2); } @@ -664,17 +539,17 @@ SwigClassWrapper swigd_ForModelEvaluator_create_operator( const_cast(this) SWIG_NO_NULL_DELETER_0); SwigClassWrapper self; self.cptr = &tempthis; - self.mem = SWIG_CREF; // since this function is const + self.cmemflags = SWIG_MEM_CONST; // since this function is const /* convert x -> class wrapper */ SwigClassWrapper farg1; farg1.cptr = const_cast*>(&x); - farg1.mem = SWIG_CREF; // x is const + farg1.cmemflags = SWIG_MEM_CONST; // x is const /* convert M -> class wrapper */ SwigClassWrapper farg2; farg2.cptr = &M; - farg2.mem = SWIG_REF; // f is mutable + farg2.cmemflags = 0; // f is mutable swigd_ForModelEvaluator_evaluate_preconditioner(&self, &farg1, &farg2); } @@ -685,7 +560,7 @@ SwigClassWrapper swigd_ForModelEvaluator_create_operator( const_cast(this) SWIG_NO_NULL_DELETER_0); SwigClassWrapper self; self.cptr = &tempthis; - self.mem = SWIG_CREF; // since this function is const + self.cmemflags = SWIG_MEM_CONST; // since this function is const SwigClassWrapper fresult = swigd_ForModelEvaluator_get_x_map(&self); @@ -699,7 +574,7 @@ SwigClassWrapper swigd_ForModelEvaluator_create_operator( const_cast(this) SWIG_NO_NULL_DELETER_0); SwigClassWrapper self; self.cptr = &tempthis; - self.mem = SWIG_CREF; // since this function is const + self.cmemflags = SWIG_MEM_CONST; // since this function is const SwigClassWrapper fresult = swigd_ForModelEvaluator_get_f_map(&self); @@ -713,7 +588,7 @@ SwigClassWrapper swigd_ForModelEvaluator_create_operator( const_cast(this) SWIG_NO_NULL_DELETER_0); SwigClassWrapper self; self.cptr = &tempthis; - self.mem = SWIG_CREF; // since this function is const + self.cmemflags = SWIG_MEM_CONST; // since this function is const SwigClassWrapper fresult = swigd_ForModelEvaluator_create_operator(&self); @@ -735,9 +610,7 @@ SwigClassWrapper swigd_ForModelEvaluator_create_operator( #include "NOX_StatusTest_Generic.H" -#ifdef __cplusplus extern "C" { -#endif SWIGEXPORT SwigClassWrapper _wrap_new_TrilinosSolver() { SwigClassWrapper fresult ; ForTrilinos::TrilinosSolver *result = 0 ; @@ -766,44 +639,11 @@ SWIGEXPORT SwigClassWrapper _wrap_new_TrilinosSolver() { } } fresult.cptr = result; - fresult.mem = (1 ? SWIG_MOVE : SWIG_REF); + fresult.cmemflags = SWIG_MEM_RVALUE | (1 ? SWIG_MEM_OWN : 0); return fresult; } -SWIGEXPORT void _wrap_TrilinosSolver_op_assign__(SwigClassWrapper *farg1, SwigClassWrapper const *farg2) { - ForTrilinos::TrilinosSolver *arg1 = (ForTrilinos::TrilinosSolver *) 0 ; - ForTrilinos::TrilinosSolver *arg2 = 0 ; - - (void)sizeof(arg1); - (void)sizeof(arg2); - { - // Make sure no unhandled exceptions exist before performing a new action - SWIG_check_unhandled_exception_impl("ForTrilinos::TrilinosSolver::operator =(ForTrilinos::TrilinosSolver const &)");; - try - { - // Attempt the wrapped function call - typedef ForTrilinos::TrilinosSolver swig_lhs_classtype; - SWIG_assign(swig_lhs_classtype, farg1, swig_lhs_classtype, farg2, 0 | swig::IS_DESTR | swig::IS_COPY_CONSTR); - } - catch (const std::range_error& e) - { - // Store a C++ exception - SWIG_exception_impl("ForTrilinos::TrilinosSolver::operator =(ForTrilinos::TrilinosSolver const &)", SWIG_IndexError, e.what(), return ); - } - catch (const std::exception& e) - { - // Store a C++ exception - SWIG_exception_impl("ForTrilinos::TrilinosSolver::operator =(ForTrilinos::TrilinosSolver const &)", SWIG_RuntimeError, e.what(), return ); - } - catch (...) - { - SWIG_exception_impl("ForTrilinos::TrilinosSolver::operator =(ForTrilinos::TrilinosSolver const &)", SWIG_UnknownError, "An unknown exception occurred", return ); - } - } -} - - SWIGEXPORT void _wrap_TrilinosSolver_init__SWIG_0(SwigClassWrapper const *farg1) { ForTrilinos::TrilinosSolver *arg1 = (ForTrilinos::TrilinosSolver *) 0 ; @@ -1042,7 +882,8 @@ SWIGEXPORT void _wrap_TrilinosSolver_finalize(SwigClassWrapper const *farg1) { SWIGEXPORT void _wrap_delete_TrilinosSolver(SwigClassWrapper *farg1) { ForTrilinos::TrilinosSolver *arg1 = (ForTrilinos::TrilinosSolver *) 0 ; - (void)sizeof(farg1); + SWIG_check_mutable(*farg1, "ForTrilinos::TrilinosSolver *", "TrilinosSolver", "ForTrilinos::TrilinosSolver::~TrilinosSolver()", return ); + arg1 = static_cast< ForTrilinos::TrilinosSolver * >(farg1->cptr); { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("ForTrilinos::TrilinosSolver::~TrilinosSolver()");; @@ -1069,6 +910,17 @@ SWIGEXPORT void _wrap_delete_TrilinosSolver(SwigClassWrapper *farg1) { } +SWIGEXPORT void _wrap_TrilinosSolver_op_assign__(SwigClassWrapper *farg1, SwigClassWrapper const *farg2) { + ForTrilinos::TrilinosSolver *arg1 = (ForTrilinos::TrilinosSolver *) 0 ; + ForTrilinos::TrilinosSolver *arg2 = 0 ; + + (void)sizeof(arg1); + (void)sizeof(arg2); + SWIG_assign(farg1, *farg2); + +} + + SWIGEXPORT SwigClassWrapper _wrap_new_TrilinosEigenSolver() { SwigClassWrapper fresult ; ForTrilinos::TrilinosEigenSolver *result = 0 ; @@ -1097,44 +949,11 @@ SWIGEXPORT SwigClassWrapper _wrap_new_TrilinosEigenSolver() { } } fresult.cptr = result; - fresult.mem = (1 ? SWIG_MOVE : SWIG_REF); + fresult.cmemflags = SWIG_MEM_RVALUE | (1 ? SWIG_MEM_OWN : 0); return fresult; } -SWIGEXPORT void _wrap_TrilinosEigenSolver_op_assign__(SwigClassWrapper *farg1, SwigClassWrapper const *farg2) { - ForTrilinos::TrilinosEigenSolver *arg1 = (ForTrilinos::TrilinosEigenSolver *) 0 ; - ForTrilinos::TrilinosEigenSolver *arg2 = 0 ; - - (void)sizeof(arg1); - (void)sizeof(arg2); - { - // Make sure no unhandled exceptions exist before performing a new action - SWIG_check_unhandled_exception_impl("ForTrilinos::TrilinosEigenSolver::operator =(ForTrilinos::TrilinosEigenSolver const &)");; - try - { - // Attempt the wrapped function call - typedef ForTrilinos::TrilinosEigenSolver swig_lhs_classtype; - SWIG_assign(swig_lhs_classtype, farg1, swig_lhs_classtype, farg2, 0 | swig::IS_DESTR | swig::IS_COPY_CONSTR); - } - catch (const std::range_error& e) - { - // Store a C++ exception - SWIG_exception_impl("ForTrilinos::TrilinosEigenSolver::operator =(ForTrilinos::TrilinosEigenSolver const &)", SWIG_IndexError, e.what(), return ); - } - catch (const std::exception& e) - { - // Store a C++ exception - SWIG_exception_impl("ForTrilinos::TrilinosEigenSolver::operator =(ForTrilinos::TrilinosEigenSolver const &)", SWIG_RuntimeError, e.what(), return ); - } - catch (...) - { - SWIG_exception_impl("ForTrilinos::TrilinosEigenSolver::operator =(ForTrilinos::TrilinosEigenSolver const &)", SWIG_UnknownError, "An unknown exception occurred", return ); - } - } -} - - SWIGEXPORT void _wrap_TrilinosEigenSolver_init__SWIG_0(SwigClassWrapper const *farg1) { ForTrilinos::TrilinosEigenSolver *arg1 = (ForTrilinos::TrilinosEigenSolver *) 0 ; @@ -1446,7 +1265,8 @@ SWIGEXPORT void _wrap_TrilinosEigenSolver_finalize(SwigClassWrapper const *farg1 SWIGEXPORT void _wrap_delete_TrilinosEigenSolver(SwigClassWrapper *farg1) { ForTrilinos::TrilinosEigenSolver *arg1 = (ForTrilinos::TrilinosEigenSolver *) 0 ; - (void)sizeof(farg1); + SWIG_check_mutable(*farg1, "ForTrilinos::TrilinosEigenSolver *", "TrilinosEigenSolver", "ForTrilinos::TrilinosEigenSolver::~TrilinosEigenSolver()", return ); + arg1 = static_cast< ForTrilinos::TrilinosEigenSolver * >(farg1->cptr); { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("ForTrilinos::TrilinosEigenSolver::~TrilinosEigenSolver()");; @@ -1473,6 +1293,17 @@ SWIGEXPORT void _wrap_delete_TrilinosEigenSolver(SwigClassWrapper *farg1) { } +SWIGEXPORT void _wrap_TrilinosEigenSolver_op_assign__(SwigClassWrapper *farg1, SwigClassWrapper const *farg2) { + ForTrilinos::TrilinosEigenSolver *arg1 = (ForTrilinos::TrilinosEigenSolver *) 0 ; + ForTrilinos::TrilinosEigenSolver *arg2 = 0 ; + + (void)sizeof(arg1); + (void)sizeof(arg2); + SWIG_assign(farg1, *farg2); + +} + + SWIGEXPORT void _wrap_ForTrilinosModelEvaluator_evaluate_residual(SwigClassWrapper const *farg1, SwigClassWrapper const *farg2, SwigClassWrapper const *farg3) { ForTrilinos::ModelEvaluator< SC,LO,GO,NO > *arg1 = (ForTrilinos::ModelEvaluator< SC,LO,GO,NO > *) 0 ; Teuchos::RCP< ForTrilinos::ModelEvaluator< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::MultiVector const > *arg2 = 0 ; @@ -1619,7 +1450,7 @@ SWIGEXPORT SwigClassWrapper _wrap_ForTrilinosModelEvaluator_get_x_map(SwigClassW } } fresult.cptr = (new Teuchos::RCP >(static_cast< const Teuchos::RCP >& >(result))); - fresult.mem = SWIG_MOVE; + fresult.cmemflags = SWIG_MEM_OWN | SWIG_MEM_RVALUE | SWIG_constsp_mem_flags; return fresult; } @@ -1656,7 +1487,7 @@ SWIGEXPORT SwigClassWrapper _wrap_ForTrilinosModelEvaluator_get_f_map(SwigClassW } } fresult.cptr = (new Teuchos::RCP >(static_cast< const Teuchos::RCP >& >(result))); - fresult.mem = SWIG_MOVE; + fresult.cmemflags = SWIG_MEM_OWN | SWIG_MEM_RVALUE | SWIG_constsp_mem_flags; return fresult; } @@ -1693,7 +1524,7 @@ SWIGEXPORT SwigClassWrapper _wrap_ForTrilinosModelEvaluator_create_operator(Swig } } fresult.cptr = (new Teuchos::RCP< Tpetra::Operator >(static_cast< const Teuchos::RCP< Tpetra::Operator >& >(result))); - fresult.mem = SWIG_MOVE; + fresult.cmemflags = SWIG_MEM_OWN | SWIG_MEM_RVALUE | SWIG_sp_mem_flags; return fresult; } @@ -1769,34 +1600,15 @@ SWIGEXPORT void _wrap_ForTrilinosModelEvaluator_op_assign__(SwigClassWrapper *fa ForTrilinos::ModelEvaluator< SC,LO,GO,NO > *arg1 = (ForTrilinos::ModelEvaluator< SC,LO,GO,NO > *) 0 ; ForTrilinos::ModelEvaluator< SC,LO,GO,NO > *arg2 = 0 ; Teuchos::RCP< ForTrilinos::ModelEvaluator< SC,LO,GO,NO > > *smartarg1 ; + Teuchos::RCP< ForTrilinos::ModelEvaluator< SC,LO,GO,NO > > *smartarg2 ; smartarg1 = static_cast< Teuchos::RCP< ForTrilinos::ModelEvaluator >* >(farg1->cptr); arg1 = smartarg1 ? const_cast< ForTrilinos::ModelEvaluator* >(smartarg1->get()) : NULL; - (void)sizeof(arg2); - { - // Make sure no unhandled exceptions exist before performing a new action - SWIG_check_unhandled_exception_impl("ForTrilinos::ModelEvaluator< SC,LO,GO,NO >::operator =(ForTrilinos::ModelEvaluator< SC,LO,GO,NO > const &)");; - try - { - // Attempt the wrapped function call - typedef Teuchos::RCP< ForTrilinos::ModelEvaluator > swig_lhs_classtype; - SWIG_assign(swig_lhs_classtype, farg1, swig_lhs_classtype, farg2, 0 | swig::IS_DESTR); - } - catch (const std::range_error& e) - { - // Store a C++ exception - SWIG_exception_impl("ForTrilinos::ModelEvaluator< SC,LO,GO,NO >::operator =(ForTrilinos::ModelEvaluator< SC,LO,GO,NO > const &)", SWIG_IndexError, e.what(), return ); - } - catch (const std::exception& e) - { - // Store a C++ exception - SWIG_exception_impl("ForTrilinos::ModelEvaluator< SC,LO,GO,NO >::operator =(ForTrilinos::ModelEvaluator< SC,LO,GO,NO > const &)", SWIG_RuntimeError, e.what(), return ); - } - catch (...) - { - SWIG_exception_impl("ForTrilinos::ModelEvaluator< SC,LO,GO,NO >::operator =(ForTrilinos::ModelEvaluator< SC,LO,GO,NO > const &)", SWIG_UnknownError, "An unknown exception occurred", return ); - } - } + SWIG_check_sp_nonnull(farg2, "ForTrilinos::ModelEvaluator< SC,LO,GO,NO > *", "ForTrilinosModelEvaluator", "ForTrilinos::ModelEvaluator< SC,LO,GO,NO >::operator =(ForTrilinos::ModelEvaluator< SC,LO,GO,NO > &)", return ) + smartarg2 = static_cast< Teuchos::RCP< ForTrilinos::ModelEvaluator >* >(farg2->cptr); + arg2 = const_cast< ForTrilinos::ModelEvaluator* >(smartarg2->get()); + SWIG_assign >, SWIGPOLICY_ForTrilinos__ModelEvaluatorT_double_int_long_long_Kokkos__Compat__KokkosSerialWrapperNode_t>(farg1, *farg2); + } @@ -2051,7 +1863,7 @@ SWIGEXPORT SwigClassWrapper _wrap_ForModelEvaluator_get_x_map(SwigClassWrapper c } } fresult.cptr = (new Teuchos::RCP >(static_cast< const Teuchos::RCP >& >(result))); - fresult.mem = SWIG_MOVE; + fresult.cmemflags = SWIG_MEM_OWN | SWIG_MEM_RVALUE | SWIG_constsp_mem_flags; return fresult; } @@ -2088,7 +1900,7 @@ SWIGEXPORT SwigClassWrapper _wrap_ForModelEvaluator_get_f_map(SwigClassWrapper c } } fresult.cptr = (new Teuchos::RCP >(static_cast< const Teuchos::RCP >& >(result))); - fresult.mem = SWIG_MOVE; + fresult.cmemflags = SWIG_MEM_OWN | SWIG_MEM_RVALUE | SWIG_constsp_mem_flags; return fresult; } @@ -2125,7 +1937,7 @@ SWIGEXPORT SwigClassWrapper _wrap_ForModelEvaluator_create_operator(SwigClassWra } } fresult.cptr = (new Teuchos::RCP< Tpetra::Operator >(static_cast< const Teuchos::RCP< Tpetra::Operator >& >(result))); - fresult.mem = SWIG_MOVE; + fresult.cmemflags = SWIG_MEM_OWN | SWIG_MEM_RVALUE | SWIG_sp_mem_flags; return fresult; } @@ -2158,7 +1970,7 @@ SWIGEXPORT SwigClassWrapper _wrap_new_ForModelEvaluator() { } } fresult.cptr = result ? new Teuchos::RCP< ForModelEvaluator >(result SWIG_NO_NULL_DELETER_1) : NULL; - fresult.mem = SWIG_MOVE; + fresult.cmemflags = SWIG_MEM_OWN | SWIG_MEM_RVALUE | SWIG_sp_mem_flags; return fresult; } @@ -2199,37 +2011,15 @@ SWIGEXPORT void _wrap_ForModelEvaluator_op_assign__(SwigClassWrapper *farg1, Swi ForModelEvaluator *arg1 = (ForModelEvaluator *) 0 ; ForModelEvaluator *arg2 = 0 ; Teuchos::RCP< ForModelEvaluator > *smartarg1 ; - Teuchos::RCP< ForModelEvaluator const > *smartarg2 ; + Teuchos::RCP< ForModelEvaluator > *smartarg2 ; smartarg1 = static_cast< Teuchos::RCP< ForModelEvaluator >* >(farg1->cptr); arg1 = smartarg1 ? const_cast< ForModelEvaluator* >(smartarg1->get()) : NULL; - SWIG_check_sp_nonnull(farg2, "ForModelEvaluator *", "ForModelEvaluator", "ForModelEvaluator::operator =(ForModelEvaluator const &)", return ) - smartarg2 = static_cast< Teuchos::RCP* >(farg2->cptr); + SWIG_check_sp_nonnull(farg2, "ForModelEvaluator *", "ForModelEvaluator", "ForModelEvaluator::operator =(ForModelEvaluator &)", return ) + smartarg2 = static_cast< Teuchos::RCP< ForModelEvaluator >* >(farg2->cptr); arg2 = const_cast< ForModelEvaluator* >(smartarg2->get()); - { - // Make sure no unhandled exceptions exist before performing a new action - SWIG_check_unhandled_exception_impl("ForModelEvaluator::operator =(ForModelEvaluator const &)");; - try - { - // Attempt the wrapped function call - typedef Teuchos::RCP< ForModelEvaluator > swig_lhs_classtype; - SWIG_assign(swig_lhs_classtype, farg1, swig_lhs_classtype, farg2, 0 | swig::IS_DESTR | swig::IS_COPY_CONSTR); - } - catch (const std::range_error& e) - { - // Store a C++ exception - SWIG_exception_impl("ForModelEvaluator::operator =(ForModelEvaluator const &)", SWIG_IndexError, e.what(), return ); - } - catch (const std::exception& e) - { - // Store a C++ exception - SWIG_exception_impl("ForModelEvaluator::operator =(ForModelEvaluator const &)", SWIG_RuntimeError, e.what(), return ); - } - catch (...) - { - SWIG_exception_impl("ForModelEvaluator::operator =(ForModelEvaluator const &)", SWIG_UnknownError, "An unknown exception occurred", return ); - } - } + SWIG_assign, SWIGPOLICY_ForModelEvaluator>(farg1, *farg2); + } @@ -2264,7 +2054,7 @@ SWIGEXPORT SwigClassWrapper _wrap_new_NOXSolver(SwigClassWrapper const *farg1) { } } fresult.cptr = result ? new Teuchos::RCP< ForTrilinos::NOXSolver >(result SWIG_NO_NULL_DELETER_1) : NULL; - fresult.mem = SWIG_MOVE; + fresult.cmemflags = SWIG_MEM_OWN | SWIG_MEM_RVALUE | SWIG_sp_mem_flags; return fresult; } @@ -2376,38 +2166,17 @@ SWIGEXPORT void _wrap_NOXSolver_op_assign__(SwigClassWrapper *farg1, SwigClassWr ForTrilinos::NOXSolver< SC,LO,GO,NO > *arg1 = (ForTrilinos::NOXSolver< SC,LO,GO,NO > *) 0 ; ForTrilinos::NOXSolver< SC,LO,GO,NO > *arg2 = 0 ; Teuchos::RCP< ForTrilinos::NOXSolver< SC,LO,GO,NO > > *smartarg1 ; + Teuchos::RCP< ForTrilinos::NOXSolver< SC,LO,GO,NO > > *smartarg2 ; smartarg1 = static_cast< Teuchos::RCP< ForTrilinos::NOXSolver >* >(farg1->cptr); arg1 = smartarg1 ? const_cast< ForTrilinos::NOXSolver* >(smartarg1->get()) : NULL; - (void)sizeof(arg2); - { - // Make sure no unhandled exceptions exist before performing a new action - SWIG_check_unhandled_exception_impl("ForTrilinos::NOXSolver< SC,LO,GO,NO >::operator =(ForTrilinos::NOXSolver< SC,LO,GO,NO > const &)");; - try - { - // Attempt the wrapped function call - typedef Teuchos::RCP< ForTrilinos::NOXSolver > swig_lhs_classtype; - SWIG_assign(swig_lhs_classtype, farg1, swig_lhs_classtype, farg2, 0 | swig::IS_DESTR | swig::IS_COPY_CONSTR); - } - catch (const std::range_error& e) - { - // Store a C++ exception - SWIG_exception_impl("ForTrilinos::NOXSolver< SC,LO,GO,NO >::operator =(ForTrilinos::NOXSolver< SC,LO,GO,NO > const &)", SWIG_IndexError, e.what(), return ); - } - catch (const std::exception& e) - { - // Store a C++ exception - SWIG_exception_impl("ForTrilinos::NOXSolver< SC,LO,GO,NO >::operator =(ForTrilinos::NOXSolver< SC,LO,GO,NO > const &)", SWIG_RuntimeError, e.what(), return ); - } - catch (...) - { - SWIG_exception_impl("ForTrilinos::NOXSolver< SC,LO,GO,NO >::operator =(ForTrilinos::NOXSolver< SC,LO,GO,NO > const &)", SWIG_UnknownError, "An unknown exception occurred", return ); - } - } + SWIG_check_sp_nonnull(farg2, "ForTrilinos::NOXSolver< SC,LO,GO,NO > *", "NOXSolver", "ForTrilinos::NOXSolver< SC,LO,GO,NO >::operator =(ForTrilinos::NOXSolver< SC,LO,GO,NO > &)", return ) + smartarg2 = static_cast< Teuchos::RCP< ForTrilinos::NOXSolver >* >(farg2->cptr); + arg2 = const_cast< ForTrilinos::NOXSolver* >(smartarg2->get()); + SWIG_assign >, SWIGPOLICY_ForTrilinos__NOXSolverT_double_int_long_long_Kokkos__Compat__KokkosSerialWrapperNode_t>(farg1, *farg2); + } -#ifdef __cplusplus -} -#endif +} // extern diff --git a/src/teuchos/src/swig/forteuchos.F90 b/src/teuchos/src/swig/forteuchos.F90 index 354d2748..6c4a3ea4 100644 --- a/src/teuchos/src/swig/forteuchos.F90 +++ b/src/teuchos/src/swig/forteuchos.F90 @@ -65,70 +65,54 @@ module forteuchos end enum integer, parameter, public :: TeuchosDataAccess = kind(TeuchosCopy) public :: TeuchosCopy, TeuchosView - enum, bind(c) - enumerator :: SWIG_NULL - enumerator :: SWIG_OWN - enumerator :: SWIG_MOVE - enumerator :: SWIG_REF - enumerator :: SWIG_CREF - end enum - integer, parameter :: SwigMemState = kind(SWIG_NULL) + + integer, parameter :: swig_cmem_own_bit = 0 + integer, parameter :: swig_cmem_rvalue_bit = 1 + integer, parameter :: swig_cmem_const_bit = 2 type, bind(C) :: SwigClassWrapper type(C_PTR), public :: cptr = C_NULL_PTR - integer(C_INT), public :: mem = SWIG_NULL + integer(C_INT), public :: cmemflags = 0 end type type, bind(C) :: SwigArrayWrapper type(C_PTR), public :: data = C_NULL_PTR integer(C_SIZE_T), public :: size = 0 end type - type, public :: SWIGTYPE_Teuchos__ArrayT_int_t - type(SwigClassWrapper), public :: swigdata - end type ! class Teuchos::Array< int > type, public :: TeuchosArrayInt type(SwigClassWrapper), public :: swigdata contains procedure :: view => swigf_TeuchosArrayInt_view - procedure :: release => delete_TeuchosArrayInt + procedure :: release => swigf_release_TeuchosArrayInt procedure, private :: swigf_TeuchosArrayInt_op_assign__ generic :: assignment(=) => swigf_TeuchosArrayInt_op_assign__ end type TeuchosArrayInt interface TeuchosArrayInt - module procedure new_TeuchosArrayInt + module procedure swigf_create_TeuchosArrayInt end interface - type, public :: SWIGTYPE_Teuchos__ArrayT_double_t - type(SwigClassWrapper), public :: swigdata - end type ! class Teuchos::Array< double > type, public :: TeuchosArrayDbl type(SwigClassWrapper), public :: swigdata contains procedure :: view => swigf_TeuchosArrayDbl_view - procedure :: release => delete_TeuchosArrayDbl + procedure :: release => swigf_release_TeuchosArrayDbl procedure, private :: swigf_TeuchosArrayDbl_op_assign__ generic :: assignment(=) => swigf_TeuchosArrayDbl_op_assign__ end type TeuchosArrayDbl interface TeuchosArrayDbl - module procedure new_TeuchosArrayDbl + module procedure swigf_create_TeuchosArrayDbl end interface - type, public :: SWIGTYPE_Teuchos__ArrayT_long_long_t - type(SwigClassWrapper), public :: swigdata - end type ! class Teuchos::Array< long long > type, public :: TeuchosArrayLongLong type(SwigClassWrapper), public :: swigdata contains procedure :: view => swigf_TeuchosArrayLongLong_view - procedure :: release => delete_TeuchosArrayLongLong + procedure :: release => swigf_release_TeuchosArrayLongLong procedure, private :: swigf_TeuchosArrayLongLong_op_assign__ generic :: assignment(=) => swigf_TeuchosArrayLongLong_op_assign__ end type TeuchosArrayLongLong interface TeuchosArrayLongLong - module procedure new_TeuchosArrayLongLong + module procedure swigf_create_TeuchosArrayLongLong end interface - type, public :: SWIGTYPE_Teuchos__CommT_int_t - type(SwigClassWrapper), public :: swigdata - end type ! class Teuchos::Comm< int > type, public :: TeuchosComm type(SwigClassWrapper), public :: swigdata @@ -137,7 +121,7 @@ module forteuchos procedure :: getSize => swigf_TeuchosComm_getSize procedure :: barrier => swigf_TeuchosComm_barrier procedure :: getRawMpiComm => swigf_TeuchosComm_getRawMpiComm - procedure :: release => delete_TeuchosComm + procedure :: release => swigf_release_TeuchosComm procedure, private :: swigf_TeuchosComm_op_assign__ generic :: assignment(=) => swigf_TeuchosComm_op_assign__ end type TeuchosComm @@ -170,7 +154,7 @@ module forteuchos procedure :: get_arr_real => swigf_ParameterList_get_arr_real procedure :: get_arr_integer => swigf_ParameterList_get_arr_integer procedure :: get_arr_longlong => swigf_ParameterList_get_arr_longlong - procedure :: release => delete_ParameterList + procedure :: release => swigf_release_ParameterList procedure, private :: swigf_ParameterList_op_assign__ generic :: assignment(=) => swigf_ParameterList_op_assign__ generic :: set => swigf_ParameterList_set__SWIG_1, swigf_ParameterList_set__SWIG_2, swigf_ParameterList_set__SWIG_3, & @@ -629,7 +613,7 @@ subroutine swigc_save_to_xml(farg1, farg2) & contains ! MODULE SUBPROGRAMS -function new_TeuchosArrayInt(arg0) & +function swigf_create_TeuchosArrayInt(arg0) & result(self) use, intrinsic :: ISO_C_BINDING type(TeuchosArrayInt) :: self @@ -667,23 +651,24 @@ function swigf_TeuchosArrayInt_view(self) & endif end function -subroutine delete_TeuchosArrayInt(self) +subroutine swigf_release_TeuchosArrayInt(self) use, intrinsic :: ISO_C_BINDING class(TeuchosArrayInt), intent(inout) :: self type(SwigClassWrapper) :: farg1 farg1 = self%swigdata -if (self%swigdata%mem == SWIG_OWN) then +if (btest(farg1%cmemflags, swig_cmem_own_bit)) then call swigc_delete_TeuchosArrayInt(farg1) -end if -self%swigdata%cptr = C_NULL_PTR -self%swigdata%mem = SWIG_NULL +endif +farg1%cptr = C_NULL_PTR +farg1%cmemflags = 0 +self%swigdata = farg1 end subroutine subroutine swigf_TeuchosArrayInt_op_assign__(self, other) use, intrinsic :: ISO_C_BINDING class(TeuchosArrayInt), intent(inout) :: self -type(SWIGTYPE_Teuchos__ArrayT_int_t), intent(in) :: other +type(TeuchosArrayInt), intent(in) :: other type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 @@ -693,7 +678,7 @@ subroutine swigf_TeuchosArrayInt_op_assign__(self, other) self%swigdata = farg1 end subroutine -function new_TeuchosArrayDbl(arg0) & +function swigf_create_TeuchosArrayDbl(arg0) & result(self) use, intrinsic :: ISO_C_BINDING type(TeuchosArrayDbl) :: self @@ -731,23 +716,24 @@ function swigf_TeuchosArrayDbl_view(self) & endif end function -subroutine delete_TeuchosArrayDbl(self) +subroutine swigf_release_TeuchosArrayDbl(self) use, intrinsic :: ISO_C_BINDING class(TeuchosArrayDbl), intent(inout) :: self type(SwigClassWrapper) :: farg1 farg1 = self%swigdata -if (self%swigdata%mem == SWIG_OWN) then +if (btest(farg1%cmemflags, swig_cmem_own_bit)) then call swigc_delete_TeuchosArrayDbl(farg1) -end if -self%swigdata%cptr = C_NULL_PTR -self%swigdata%mem = SWIG_NULL +endif +farg1%cptr = C_NULL_PTR +farg1%cmemflags = 0 +self%swigdata = farg1 end subroutine subroutine swigf_TeuchosArrayDbl_op_assign__(self, other) use, intrinsic :: ISO_C_BINDING class(TeuchosArrayDbl), intent(inout) :: self -type(SWIGTYPE_Teuchos__ArrayT_double_t), intent(in) :: other +type(TeuchosArrayDbl), intent(in) :: other type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 @@ -757,7 +743,7 @@ subroutine swigf_TeuchosArrayDbl_op_assign__(self, other) self%swigdata = farg1 end subroutine -function new_TeuchosArrayLongLong(arg0) & +function swigf_create_TeuchosArrayLongLong(arg0) & result(self) use, intrinsic :: ISO_C_BINDING type(TeuchosArrayLongLong) :: self @@ -795,23 +781,24 @@ function swigf_TeuchosArrayLongLong_view(self) & endif end function -subroutine delete_TeuchosArrayLongLong(self) +subroutine swigf_release_TeuchosArrayLongLong(self) use, intrinsic :: ISO_C_BINDING class(TeuchosArrayLongLong), intent(inout) :: self type(SwigClassWrapper) :: farg1 farg1 = self%swigdata -if (self%swigdata%mem == SWIG_OWN) then +if (btest(farg1%cmemflags, swig_cmem_own_bit)) then call swigc_delete_TeuchosArrayLongLong(farg1) -end if -self%swigdata%cptr = C_NULL_PTR -self%swigdata%mem = SWIG_NULL +endif +farg1%cptr = C_NULL_PTR +farg1%cmemflags = 0 +self%swigdata = farg1 end subroutine subroutine swigf_TeuchosArrayLongLong_op_assign__(self, other) use, intrinsic :: ISO_C_BINDING class(TeuchosArrayLongLong), intent(inout) :: self -type(SWIGTYPE_Teuchos__ArrayT_long_long_t), intent(in) :: other +type(TeuchosArrayLongLong), intent(in) :: other type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 @@ -892,23 +879,24 @@ function swigf_TeuchosComm_getRawMpiComm(self) & swig_result = int(fresult) end function -subroutine delete_TeuchosComm(self) +subroutine swigf_release_TeuchosComm(self) use, intrinsic :: ISO_C_BINDING class(TeuchosComm), intent(inout) :: self type(SwigClassWrapper) :: farg1 farg1 = self%swigdata -if (self%swigdata%mem == SWIG_OWN) then +if (btest(farg1%cmemflags, swig_cmem_own_bit)) then call swigc_delete_TeuchosComm(farg1) -end if -self%swigdata%cptr = C_NULL_PTR -self%swigdata%mem = SWIG_NULL +endif +farg1%cptr = C_NULL_PTR +farg1%cmemflags = 0 +self%swigdata = farg1 end subroutine subroutine swigf_TeuchosComm_op_assign__(self, other) use, intrinsic :: ISO_C_BINDING class(TeuchosComm), intent(inout) :: self -type(SWIGTYPE_Teuchos__CommT_int_t), intent(in) :: other +type(TeuchosComm), intent(in) :: other type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 @@ -1373,17 +1361,18 @@ function swigf_ParameterList_get_arr_longlong(self, name) & endif end function -subroutine delete_ParameterList(self) +subroutine swigf_release_ParameterList(self) use, intrinsic :: ISO_C_BINDING class(ParameterList), intent(inout) :: self type(SwigClassWrapper) :: farg1 farg1 = self%swigdata -if (self%swigdata%mem == SWIG_OWN) then +if (btest(farg1%cmemflags, swig_cmem_own_bit)) then call swigc_delete_ParameterList(farg1) -end if -self%swigdata%cptr = C_NULL_PTR -self%swigdata%mem = SWIG_NULL +endif +farg1%cptr = C_NULL_PTR +farg1%cmemflags = 0 +self%swigdata = farg1 end subroutine subroutine swigf_ParameterList_op_assign__(self, other) diff --git a/src/teuchos/src/swig/forteuchosFORTRAN_wrap.cxx b/src/teuchos/src/swig/forteuchosFORTRAN_wrap.cxx index 2412912e..7d7b5d6f 100644 --- a/src/teuchos/src/swig/forteuchosFORTRAN_wrap.cxx +++ b/src/teuchos/src/swig/forteuchosFORTRAN_wrap.cxx @@ -205,8 +205,15 @@ void SWIG_store_exception(const char* decl, int errcode, const char *msg); SWIG_store_exception(DECL, CODE, MSG); RETURNNULL; +enum SwigMemFlags { + SWIG_MEM_OWN = 0x01, + SWIG_MEM_RVALUE = 0x02, + SWIG_MEM_CONST = 0x04 +}; + + #define SWIG_check_mutable(SWIG_CLASS_WRAPPER, TYPENAME, FNAME, FUNCNAME, RETURNNULL) \ - if ((SWIG_CLASS_WRAPPER).mem == SWIG_CREF) { \ + if ((SWIG_CLASS_WRAPPER).cmemflags & SWIG_MEM_CONST) { \ SWIG_exception_impl(FUNCNAME, SWIG_TypeError, \ "Cannot pass const " TYPENAME " (class " FNAME ") " \ "as a mutable reference", \ @@ -215,7 +222,7 @@ void SWIG_store_exception(const char* decl, int errcode, const char *msg); #define SWIG_check_nonnull(SWIG_CLASS_WRAPPER, TYPENAME, FNAME, FUNCNAME, RETURNNULL) \ - if ((SWIG_CLASS_WRAPPER).mem == SWIG_NULL) { \ + if (!(SWIG_CLASS_WRAPPER).cptr) { \ SWIG_exception_impl(FUNCNAME, SWIG_TypeError, \ "Cannot pass null " TYPENAME " (class " FNAME ") " \ "as a reference", RETURNNULL); \ @@ -228,24 +235,14 @@ void SWIG_store_exception(const char* decl, int errcode, const char *msg); namespace swig { - -enum AssignmentFlags { - IS_DESTR = 0x01, - IS_COPY_CONSTR = 0x02, - IS_COPY_ASSIGN = 0x04, - IS_MOVE_CONSTR = 0x08, - IS_MOVE_ASSIGN = 0x10 +enum AssignmentType { + ASSIGNMENT_DEFAULT, + ASSIGNMENT_NODESTRUCT, + ASSIGNMENT_SMARTPTR }; - -template -struct assignment_flags; } -#define SWIG_assign(LEFTTYPE, LEFT, RIGHTTYPE, RIGHT, FLAGS) \ - SWIG_assign_impl::value >(LEFT, RIGHT); - - #define SWIG_check_sp_nonnull(INPUT, TYPENAME, FNAME, FUNCNAME, RETURNNULL) \ if (!(INPUT)) { \ SWIG_exception_impl(FUNCNAME, SWIG_TypeError, \ @@ -253,6 +250,15 @@ struct assignment_flags; "as a reference", RETURNNULL); \ } +#define SWIG_constsp_mem_flags SWIG_MEM_CONST +#define SWIG_sp_mem_flags 0 + + +#define SWIGPOLICY_Teuchos__ArrayT_int_t swig::ASSIGNMENT_DEFAULT +#define SWIGPOLICY_Teuchos__ArrayT_double_t swig::ASSIGNMENT_DEFAULT +#define SWIGPOLICY_Teuchos__ArrayT_long_long_t swig::ASSIGNMENT_DEFAULT +#define SWIGPOLICY_Teuchos__CommT_int_t swig::ASSIGNMENT_SMARTPTR +#define SWIGPOLICY_Teuchos__ParameterList swig::ASSIGNMENT_SMARTPTR #include @@ -296,25 +302,16 @@ struct assignment_flags; #include "Teuchos_Array.hpp" -enum SwigMemState { - SWIG_NULL, - SWIG_OWN, - SWIG_MOVE, - SWIG_REF, - SWIG_CREF -}; - - struct SwigClassWrapper { void* cptr; - SwigMemState mem; + int cmemflags; }; SWIGINTERN SwigClassWrapper SwigClassWrapper_uninitialized() { SwigClassWrapper result; result.cptr = NULL; - result.mem = SWIG_NULL; + result.cmemflags = 0; return result; } @@ -347,229 +344,107 @@ SWIGINTERN Teuchos::ArrayView< int > Teuchos_Array_Sl_int_Sg__view(Teuchos::Arra return (*self)(); } -#include - - namespace swig { -// Define our own switching struct to support pre-c++11 builds -template -struct bool_constant {}; -typedef bool_constant true_type; -typedef bool_constant false_type; - -// Deletion -template -SWIGINTERN void destruct_impl(T* self, true_type) { - delete self; -} +template +struct DestructorPolicy { + static SwigClassWrapper destruct(SwigClassWrapper self) { + delete static_cast(self.cptr); + return SwigClassWrapper_uninitialized(); + } +}; template -SWIGINTERN T* destruct_impl(T* , false_type) { - SWIG_exception_impl("assignment", SWIG_TypeError, - "Invalid assignment: class type has no destructor", - return NULL); -} - -// Copy construction and assignment -template -SWIGINTERN T* copy_construct_impl(const U* other, true_type) { - return new T(*other); -} -template -SWIGINTERN void copy_assign_impl(T* self, const U* other, true_type) { - *self = *other; -} - -// Disabled construction and assignment -template -SWIGINTERN T* copy_construct_impl(const U* , false_type) { - SWIG_exception_impl("assignment", SWIG_TypeError, - "Invalid assignment: class type has no copy constructor", - return NULL); -} -template -SWIGINTERN void copy_assign_impl(T* , const U* , false_type) { - SWIG_exception_impl("assignment", SWIG_TypeError, - "Invalid assignment: class type has no copy assignment", - return); -} - -#if __cplusplus >= 201103L -#include -#include - -// Move construction and assignment -template -SWIGINTERN T* move_construct_impl(U* other, true_type) { - return new T(std::move(*other)); -} -template -SWIGINTERN void move_assign_impl(T* self, U* other, true_type) { - *self = std::move(*other); -} - -// Disabled move construction and assignment -template -SWIGINTERN T* move_construct_impl(U*, false_type) { - SWIG_exception_impl("assignment", SWIG_TypeError, - "Invalid assignment: class type has no move constructor", - return NULL); -} -template -SWIGINTERN void move_assign_impl(T*, U*, false_type) { - SWIG_exception_impl("assignment", SWIG_TypeError, - "Invalid assignment: class type has no move assignment", - return); -} - -template -struct assignment_flags { - constexpr static int value = - (std::is_destructible::value ? IS_DESTR : 0) - | (std::is_copy_constructible::value ? IS_COPY_CONSTR : 0) - | (std::is_copy_assignable::value ? IS_COPY_ASSIGN : 0) - | (std::is_move_constructible::value ? IS_MOVE_CONSTR : 0) - | (std::is_move_assignable::value ? IS_MOVE_ASSIGN : 0); +struct DestructorPolicy { + static SwigClassWrapper destruct(SwigClassWrapper self) { + SWIG_exception_impl("assignment", SWIG_TypeError, "Invalid assignment: class type has private destructor", return SwigClassWrapper_uninitialized()); + } }; +} -#else - -template -struct assignment_flags { - enum { value = Flags }; -}; -#endif +namespace swig { -template -struct AssignmentTraits { - static void destruct(T* self) { - destruct_impl(self, bool_constant()); +template +struct AssignmentPolicy { + static SwigClassWrapper destruct(SwigClassWrapper self) { + return DestructorPolicy::destruct(self); } - - template - static T* copy_construct(const U* other) { - return copy_construct_impl(other, bool_constant()); + static SwigClassWrapper alias(SwigClassWrapper other) { + SwigClassWrapper self; + self.cptr = other.cptr; + self.cmemflags = other.cmemflags & ~SWIG_MEM_OWN; + return self; } - - template - static void copy_assign(T* self, const U* other) { - copy_assign_impl(self, other, bool_constant()); + static SwigClassWrapper move_alias(SwigClassWrapper self, SwigClassWrapper other) { + if (self.cmemflags & SWIG_MEM_OWN) { + destruct(self); + } + self.cptr = other.cptr; + self.cmemflags = other.cmemflags & ~SWIG_MEM_RVALUE; + return self; } + static SwigClassWrapper copy_alias(SwigClassWrapper self, SwigClassWrapper other) { + if (self.cmemflags & SWIG_MEM_OWN) { + destruct(self); + } + self.cptr = other.cptr; + self.cmemflags = other.cmemflags & ~SWIG_MEM_OWN; + return self; + } +}; -#if __cplusplus >= 201103L - template - static T* move_construct(U* other) { - return move_construct_impl(other, bool_constant()); +template +struct AssignmentPolicy { + static SwigClassWrapper destruct(SwigClassWrapper self) { + return DestructorPolicy::destruct(self); } - template - static void move_assign(T* self, U* other) { - move_assign_impl(self, other, bool_constant()); + static SwigClassWrapper alias(SwigClassWrapper other) { + SwigClassWrapper self; + self.cptr = new T(*static_cast(other.cptr)); + self.cmemflags = other.cmemflags | SWIG_MEM_OWN; + return self; } -#else - template - static T* move_construct(U* other) { - return copy_construct_impl(other, bool_constant()); + static SwigClassWrapper move_alias(SwigClassWrapper self, SwigClassWrapper other) { + self = copy_alias(self, other); + self.cmemflags = other.cmemflags & ~SWIG_MEM_RVALUE; + destruct(other); + return self; } - template - static void move_assign(T* self, U* other) { - copy_assign_impl(self, other, bool_constant()); + static SwigClassWrapper copy_alias(SwigClassWrapper self, SwigClassWrapper other) { + // LHS and RHS should both 'own' their shared pointers + T *pself = static_cast(self.cptr); + T *pother = static_cast(other.cptr); + *pself = *pother; + return self; } -#endif }; } // end namespace swig - -template -SWIGINTERN void SWIG_assign_impl(SwigClassWrapper* self, const SwigClassWrapper* other) { - typedef swig::AssignmentTraits Traits_t; - T1* pself = static_cast(self->cptr); - T2* pother = static_cast(other->cptr); - - switch (self->mem) { - case SWIG_NULL: - /* LHS is unassigned */ - switch (other->mem) { - case SWIG_NULL: /* null op */ - break; - case SWIG_MOVE: /* capture pointer from RHS */ - self->cptr = other->cptr; - self->mem = SWIG_OWN; - break; - case SWIG_OWN: /* copy from RHS */ - self->cptr = Traits_t::copy_construct(pother); - self->mem = SWIG_OWN; - break; - case SWIG_REF: /* pointer to RHS */ - case SWIG_CREF: - self->cptr = other->cptr; - self->mem = other->mem; - break; - } - break; - case SWIG_OWN: - /* LHS owns memory */ - switch (other->mem) { - case SWIG_NULL: - /* Delete LHS */ - Traits_t::destruct(pself); - self->cptr = NULL; - self->mem = SWIG_NULL; - break; - case SWIG_MOVE: - /* Move RHS into LHS; delete RHS */ - Traits_t::move_assign(pself, pother); - Traits_t::destruct(pother); - break; - case SWIG_OWN: - case SWIG_REF: - case SWIG_CREF: - /* Copy RHS to LHS */ - Traits_t::copy_assign(pself, pother); - break; - } - break; - case SWIG_MOVE: - SWIG_exception_impl("assignment", SWIG_RuntimeError, - "Left-hand side of assignment should never be in a 'MOVE' state", - return); - break; - case SWIG_REF: - /* LHS is a reference */ - switch (other->mem) { - case SWIG_NULL: - /* Remove LHS reference */ - self->cptr = NULL; - self->mem = SWIG_NULL; - break; - case SWIG_MOVE: - /* Move RHS into LHS; delete RHS. The original ownership stays the - * same. */ - Traits_t::move_assign(pself, pother); - Traits_t::destruct(pother); - break; - case SWIG_OWN: - case SWIG_REF: - case SWIG_CREF: - /* Copy RHS to LHS */ - Traits_t::copy_assign(pself, pother); - break; - } - break; - case SWIG_CREF: - switch (other->mem) { - case SWIG_NULL: - /* Remove LHS reference */ - self->cptr = NULL; - self->mem = SWIG_NULL; - break; - default: - SWIG_exception_impl("assignment", SWIG_RuntimeError, - "Cannot assign to a const reference", return); - break; - } - break; +template +SWIGINTERN void SWIG_assign(SwigClassWrapper* self, SwigClassWrapper other) { + typedef swig::AssignmentPolicy Policy_t; + + if (self->cptr == NULL) { + /* LHS is unassigned */ + if (other.cmemflags & SWIG_MEM_RVALUE) { + /* Capture pointer from RHS, clear 'moving' flag */ + self->cptr = other.cptr; + self->cmemflags = other.cmemflags & (~SWIG_MEM_RVALUE); + } else { + /* Aliasing another class; clear ownership or copy smart pointer */ + *self = Policy_t::alias(other); + } + } else if (other.cptr == NULL) { + /* Replace LHS with a null pointer */ + *self = Policy_t::destruct(*self); + } else if (other.cmemflags & SWIG_MEM_RVALUE) { + /* Transferred ownership from a variable that's about to be lost. + * Move-assign and delete the transient data */ + *self = Policy_t::move_alias(*self, other); + } else { + /* RHS shouldn't be deleted, alias to LHS */ + *self = Policy_t::copy_alias(*self, other); } } @@ -635,9 +510,7 @@ void save_to_xml(const Teuchos::ParameterList& plist, Teuchos::writeParameterListToXmlFile(plist, xml_path); } -#ifdef __cplusplus extern "C" { -#endif SWIGEXPORT SwigClassWrapper _wrap_new_TeuchosArrayInt(SwigArrayWrapper *farg1) { SwigClassWrapper fresult ; Teuchos::ArrayView< int const > *arg1 = 0 ; @@ -670,7 +543,7 @@ SWIGEXPORT SwigClassWrapper _wrap_new_TeuchosArrayInt(SwigArrayWrapper *farg1) { } } fresult.cptr = result; - fresult.mem = (1 ? SWIG_MOVE : SWIG_REF); + fresult.cmemflags = SWIG_MEM_RVALUE | (1 ? SWIG_MEM_OWN : 0); return fresult; } @@ -714,7 +587,8 @@ SWIGEXPORT SwigArrayWrapper _wrap_TeuchosArrayInt_view(SwigClassWrapper const *f SWIGEXPORT void _wrap_delete_TeuchosArrayInt(SwigClassWrapper *farg1) { Teuchos::Array< int > *arg1 = (Teuchos::Array< int > *) 0 ; - (void)sizeof(farg1); + SWIG_check_mutable(*farg1, "Teuchos::Array< int > *", "TeuchosArrayInt", "Teuchos::Array< int >::~Array()", return ); + arg1 = static_cast< Teuchos::Array< int > * >(farg1->cptr); { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Teuchos::Array< int >::~Array()");; @@ -747,30 +621,8 @@ SWIGEXPORT void _wrap_TeuchosArrayInt_op_assign__(SwigClassWrapper *farg1, SwigC (void)sizeof(arg1); (void)sizeof(arg2); - { - // Make sure no unhandled exceptions exist before performing a new action - SWIG_check_unhandled_exception_impl("Teuchos::Array< int >::operator =(Teuchos::Array< int > const &)");; - try - { - // Attempt the wrapped function call - typedef Teuchos::Array< int > swig_lhs_classtype; - SWIG_assign(swig_lhs_classtype, farg1, swig_lhs_classtype, farg2, 0 | swig::IS_DESTR | swig::IS_COPY_CONSTR); - } - catch (const std::range_error& e) - { - // Store a C++ exception - SWIG_exception_impl("Teuchos::Array< int >::operator =(Teuchos::Array< int > const &)", SWIG_IndexError, e.what(), return ); - } - catch (const std::exception& e) - { - // Store a C++ exception - SWIG_exception_impl("Teuchos::Array< int >::operator =(Teuchos::Array< int > const &)", SWIG_RuntimeError, e.what(), return ); - } - catch (...) - { - SWIG_exception_impl("Teuchos::Array< int >::operator =(Teuchos::Array< int > const &)", SWIG_UnknownError, "An unknown exception occurred", return ); - } - } + SWIG_assign, SWIGPOLICY_Teuchos__ArrayT_int_t>(farg1, *farg2); + } @@ -806,7 +658,7 @@ SWIGEXPORT SwigClassWrapper _wrap_new_TeuchosArrayDbl(SwigArrayWrapper *farg1) { } } fresult.cptr = result; - fresult.mem = (1 ? SWIG_MOVE : SWIG_REF); + fresult.cmemflags = SWIG_MEM_RVALUE | (1 ? SWIG_MEM_OWN : 0); return fresult; } @@ -850,7 +702,8 @@ SWIGEXPORT SwigArrayWrapper _wrap_TeuchosArrayDbl_view(SwigClassWrapper const *f SWIGEXPORT void _wrap_delete_TeuchosArrayDbl(SwigClassWrapper *farg1) { Teuchos::Array< double > *arg1 = (Teuchos::Array< double > *) 0 ; - (void)sizeof(farg1); + SWIG_check_mutable(*farg1, "Teuchos::Array< double > *", "TeuchosArrayDbl", "Teuchos::Array< double >::~Array()", return ); + arg1 = static_cast< Teuchos::Array< double > * >(farg1->cptr); { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Teuchos::Array< double >::~Array()");; @@ -883,30 +736,8 @@ SWIGEXPORT void _wrap_TeuchosArrayDbl_op_assign__(SwigClassWrapper *farg1, SwigC (void)sizeof(arg1); (void)sizeof(arg2); - { - // Make sure no unhandled exceptions exist before performing a new action - SWIG_check_unhandled_exception_impl("Teuchos::Array< double >::operator =(Teuchos::Array< double > const &)");; - try - { - // Attempt the wrapped function call - typedef Teuchos::Array< double > swig_lhs_classtype; - SWIG_assign(swig_lhs_classtype, farg1, swig_lhs_classtype, farg2, 0 | swig::IS_DESTR | swig::IS_COPY_CONSTR); - } - catch (const std::range_error& e) - { - // Store a C++ exception - SWIG_exception_impl("Teuchos::Array< double >::operator =(Teuchos::Array< double > const &)", SWIG_IndexError, e.what(), return ); - } - catch (const std::exception& e) - { - // Store a C++ exception - SWIG_exception_impl("Teuchos::Array< double >::operator =(Teuchos::Array< double > const &)", SWIG_RuntimeError, e.what(), return ); - } - catch (...) - { - SWIG_exception_impl("Teuchos::Array< double >::operator =(Teuchos::Array< double > const &)", SWIG_UnknownError, "An unknown exception occurred", return ); - } - } + SWIG_assign, SWIGPOLICY_Teuchos__ArrayT_double_t>(farg1, *farg2); + } @@ -942,7 +773,7 @@ SWIGEXPORT SwigClassWrapper _wrap_new_TeuchosArrayLongLong(SwigArrayWrapper *far } } fresult.cptr = result; - fresult.mem = (1 ? SWIG_MOVE : SWIG_REF); + fresult.cmemflags = SWIG_MEM_RVALUE | (1 ? SWIG_MEM_OWN : 0); return fresult; } @@ -986,7 +817,8 @@ SWIGEXPORT SwigArrayWrapper _wrap_TeuchosArrayLongLong_view(SwigClassWrapper con SWIGEXPORT void _wrap_delete_TeuchosArrayLongLong(SwigClassWrapper *farg1) { Teuchos::Array< long long > *arg1 = (Teuchos::Array< long long > *) 0 ; - (void)sizeof(farg1); + SWIG_check_mutable(*farg1, "Teuchos::Array< long long > *", "TeuchosArrayLongLong", "Teuchos::Array< long long >::~Array()", return ); + arg1 = static_cast< Teuchos::Array< long long > * >(farg1->cptr); { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Teuchos::Array< long long >::~Array()");; @@ -1019,30 +851,8 @@ SWIGEXPORT void _wrap_TeuchosArrayLongLong_op_assign__(SwigClassWrapper *farg1, (void)sizeof(arg1); (void)sizeof(arg2); - { - // Make sure no unhandled exceptions exist before performing a new action - SWIG_check_unhandled_exception_impl("Teuchos::Array< long long >::operator =(Teuchos::Array< long long > const &)");; - try - { - // Attempt the wrapped function call - typedef Teuchos::Array< long long > swig_lhs_classtype; - SWIG_assign(swig_lhs_classtype, farg1, swig_lhs_classtype, farg2, 0 | swig::IS_DESTR | swig::IS_COPY_CONSTR); - } - catch (const std::range_error& e) - { - // Store a C++ exception - SWIG_exception_impl("Teuchos::Array< long long >::operator =(Teuchos::Array< long long > const &)", SWIG_IndexError, e.what(), return ); - } - catch (const std::exception& e) - { - // Store a C++ exception - SWIG_exception_impl("Teuchos::Array< long long >::operator =(Teuchos::Array< long long > const &)", SWIG_RuntimeError, e.what(), return ); - } - catch (...) - { - SWIG_exception_impl("Teuchos::Array< long long >::operator =(Teuchos::Array< long long > const &)", SWIG_UnknownError, "An unknown exception occurred", return ); - } - } + SWIG_assign, SWIGPOLICY_Teuchos__ArrayT_long_long_t>(farg1, *farg2); + } @@ -1184,7 +994,7 @@ SWIGEXPORT SwigClassWrapper _wrap_new_TeuchosComm__SWIG_0(int const *farg1) { } } fresult.cptr = result ? new Teuchos::RCP< Teuchos::Comm >(result SWIG_NO_NULL_DELETER_1) : NULL; - fresult.mem = SWIG_MOVE; + fresult.cmemflags = SWIG_MEM_OWN | SWIG_MEM_RVALUE | SWIG_sp_mem_flags; return fresult; } @@ -1217,7 +1027,7 @@ SWIGEXPORT SwigClassWrapper _wrap_new_TeuchosComm__SWIG_1() { } } fresult.cptr = result ? new Teuchos::RCP< Teuchos::Comm >(result SWIG_NO_NULL_DELETER_1) : NULL; - fresult.mem = SWIG_MOVE; + fresult.cmemflags = SWIG_MEM_OWN | SWIG_MEM_RVALUE | SWIG_sp_mem_flags; return fresult; } @@ -1298,34 +1108,15 @@ SWIGEXPORT void _wrap_TeuchosComm_op_assign__(SwigClassWrapper *farg1, SwigClass Teuchos::Comm< int > *arg1 = (Teuchos::Comm< int > *) 0 ; Teuchos::Comm< int > *arg2 = 0 ; Teuchos::RCP< Teuchos::Comm< int > > *smartarg1 ; + Teuchos::RCP< Teuchos::Comm< int > > *smartarg2 ; smartarg1 = static_cast< Teuchos::RCP< Teuchos::Comm >* >(farg1->cptr); arg1 = smartarg1 ? const_cast< Teuchos::Comm* >(smartarg1->get()) : NULL; - (void)sizeof(arg2); - { - // Make sure no unhandled exceptions exist before performing a new action - SWIG_check_unhandled_exception_impl("Teuchos::Comm< int >::operator =(Teuchos::Comm< int > const &)");; - try - { - // Attempt the wrapped function call - typedef Teuchos::RCP< Teuchos::Comm > swig_lhs_classtype; - SWIG_assign(swig_lhs_classtype, farg1, swig_lhs_classtype, farg2, 0 | swig::IS_DESTR | swig::IS_COPY_CONSTR); - } - catch (const std::range_error& e) - { - // Store a C++ exception - SWIG_exception_impl("Teuchos::Comm< int >::operator =(Teuchos::Comm< int > const &)", SWIG_IndexError, e.what(), return ); - } - catch (const std::exception& e) - { - // Store a C++ exception - SWIG_exception_impl("Teuchos::Comm< int >::operator =(Teuchos::Comm< int > const &)", SWIG_RuntimeError, e.what(), return ); - } - catch (...) - { - SWIG_exception_impl("Teuchos::Comm< int >::operator =(Teuchos::Comm< int > const &)", SWIG_UnknownError, "An unknown exception occurred", return ); - } - } + SWIG_check_sp_nonnull(farg2, "Teuchos::Comm< int > *", "TeuchosComm", "Teuchos::Comm< int >::operator =(Teuchos::Comm< int > &)", return ) + smartarg2 = static_cast< Teuchos::RCP< Teuchos::Comm >* >(farg2->cptr); + arg2 = const_cast< Teuchos::Comm* >(smartarg2->get()); + SWIG_assign >, SWIGPOLICY_Teuchos__CommT_int_t>(farg1, *farg2); + } @@ -1357,7 +1148,7 @@ SWIGEXPORT SwigClassWrapper _wrap_new_ParameterList__SWIG_0() { } } fresult.cptr = result ? new Teuchos::RCP< Teuchos::ParameterList >(result SWIG_NO_NULL_DELETER_1) : NULL; - fresult.mem = SWIG_MOVE; + fresult.cmemflags = SWIG_MEM_OWN | SWIG_MEM_RVALUE | SWIG_sp_mem_flags; return fresult; } @@ -1394,7 +1185,7 @@ SWIGEXPORT SwigClassWrapper _wrap_new_ParameterList__SWIG_1(SwigArrayWrapper *fa } } fresult.cptr = result ? new Teuchos::RCP< Teuchos::ParameterList >(result SWIG_NO_NULL_DELETER_1) : NULL; - fresult.mem = SWIG_MOVE; + fresult.cmemflags = SWIG_MEM_OWN | SWIG_MEM_RVALUE | SWIG_sp_mem_flags; return fresult; } @@ -1544,7 +1335,7 @@ SWIGEXPORT SwigClassWrapper _wrap_ParameterList_sublist(SwigClassWrapper const * } { fresult.cptr = new Teuchos::RCP< Teuchos::ParameterList >(result SWIG_NO_NULL_DELETER_0); - fresult.mem = SWIG_MOVE; + fresult.cmemflags = SWIG_MEM_OWN | SWIG_MEM_RVALUE | SWIG_sp_mem_flags; } return fresult; } @@ -2277,37 +2068,15 @@ SWIGEXPORT void _wrap_ParameterList_op_assign__(SwigClassWrapper *farg1, SwigCla Teuchos::ParameterList *arg1 = (Teuchos::ParameterList *) 0 ; Teuchos::ParameterList *arg2 = 0 ; Teuchos::RCP< Teuchos::ParameterList > *smartarg1 ; - Teuchos::RCP< Teuchos::ParameterList const > *smartarg2 ; + Teuchos::RCP< Teuchos::ParameterList > *smartarg2 ; smartarg1 = static_cast< Teuchos::RCP< Teuchos::ParameterList >* >(farg1->cptr); arg1 = smartarg1 ? const_cast< Teuchos::ParameterList* >(smartarg1->get()) : NULL; - SWIG_check_sp_nonnull(farg2, "Teuchos::ParameterList *", "ParameterList", "Teuchos::ParameterList::operator =(Teuchos::ParameterList const &)", return ) - smartarg2 = static_cast< Teuchos::RCP* >(farg2->cptr); + SWIG_check_sp_nonnull(farg2, "Teuchos::ParameterList *", "ParameterList", "Teuchos::ParameterList::operator =(Teuchos::ParameterList &)", return ) + smartarg2 = static_cast< Teuchos::RCP< Teuchos::ParameterList >* >(farg2->cptr); arg2 = const_cast< Teuchos::ParameterList* >(smartarg2->get()); - { - // Make sure no unhandled exceptions exist before performing a new action - SWIG_check_unhandled_exception_impl("Teuchos::ParameterList::operator =(Teuchos::ParameterList const &)");; - try - { - // Attempt the wrapped function call - typedef Teuchos::RCP< Teuchos::ParameterList > swig_lhs_classtype; - SWIG_assign(swig_lhs_classtype, farg1, swig_lhs_classtype, farg2, 0 | swig::IS_DESTR | swig::IS_COPY_CONSTR); - } - catch (const std::range_error& e) - { - // Store a C++ exception - SWIG_exception_impl("Teuchos::ParameterList::operator =(Teuchos::ParameterList const &)", SWIG_IndexError, e.what(), return ); - } - catch (const std::exception& e) - { - // Store a C++ exception - SWIG_exception_impl("Teuchos::ParameterList::operator =(Teuchos::ParameterList const &)", SWIG_RuntimeError, e.what(), return ); - } - catch (...) - { - SWIG_exception_impl("Teuchos::ParameterList::operator =(Teuchos::ParameterList const &)", SWIG_UnknownError, "An unknown exception occurred", return ); - } - } + SWIG_assign, SWIGPOLICY_Teuchos__ParameterList>(farg1, *farg2); + } @@ -2383,7 +2152,5 @@ SWIGEXPORT void _wrap_save_to_xml(SwigClassWrapper const *farg1, SwigArrayWrappe } -#ifdef __cplusplus -} -#endif +} // extern diff --git a/src/tpetra/src/Tpetra_Operator.i b/src/tpetra/src/Tpetra_Operator.i index 8bb89814..443c9956 100644 --- a/src/tpetra/src/Tpetra_Operator.i +++ b/src/tpetra/src/Tpetra_Operator.i @@ -91,7 +91,7 @@ SwigClassWrapper swigd_ForTpetraOperator_getRangeMap( const_cast(this) SWIG_NO_NULL_DELETER_0); SwigClassWrapper self; self.cptr = &tempthis; - self.mem = SWIG_CREF; // since this function is const + self.cmemflags = SWIG_MEM_CONST; SwigClassWrapper fresult = swigd_ForTpetraOperator_getDomainMap(&self); @@ -105,7 +105,7 @@ SwigClassWrapper swigd_ForTpetraOperator_getRangeMap( const_cast(this) SWIG_NO_NULL_DELETER_0); SwigClassWrapper self; self.cptr = &tempthis; - self.mem = SWIG_CREF; // since this function is const + self.cmemflags = SWIG_MEM_CONST; SwigClassWrapper fresult = swigd_ForTpetraOperator_getRangeMap(&self); @@ -121,20 +121,20 @@ SwigClassWrapper swigd_ForTpetraOperator_getRangeMap( const_cast(this) SWIG_NO_NULL_DELETER_0); SwigClassWrapper self; self.cptr = &tempthis; - self.mem = SWIG_CREF; // since this function is const + self.cmemflags = SWIG_MEM_CONST; /* convert X -> class wrapper */ Teuchos::RCP > temprcp1(&X SWIG_NO_NULL_DELETER_0); SwigClassWrapper farg1; farg1.cptr = &temprcp1; - farg1.mem = SWIG_CREF; // X is const + farg1.cmemflags = SWIG_MEM_CONST; Teuchos::RCP< Tpetra::MultiVector > temprcp2(&Y SWIG_NO_NULL_DELETER_0); SwigClassWrapper farg2; farg2.cptr = &temprcp2; - farg2.mem = SWIG_REF; // Y is mutable + farg2.cmemflags = 0; /* convert scalars to wrappers */ int farg3 = mode; diff --git a/src/tpetra/src/swig/fortpetra.F90 b/src/tpetra/src/swig/fortpetra.F90 index 7852f6ef..811d16f1 100644 --- a/src/tpetra/src/swig/fortpetra.F90 +++ b/src/tpetra/src/swig/fortpetra.F90 @@ -93,17 +93,13 @@ module fortpetra end enum integer, parameter, public :: TpetraCombineMode = kind(TpetraADD) public :: TpetraADD, TpetraINSERT, TpetraREPLACE, TpetraABSMAX, TpetraZERO - enum, bind(c) - enumerator :: SWIG_NULL - enumerator :: SWIG_OWN - enumerator :: SWIG_MOVE - enumerator :: SWIG_REF - enumerator :: SWIG_CREF - end enum - integer, parameter :: SwigMemState = kind(SWIG_NULL) + + integer, parameter :: swig_cmem_own_bit = 0 + integer, parameter :: swig_cmem_rvalue_bit = 1 + integer, parameter :: swig_cmem_const_bit = 2 type, bind(C) :: SwigClassWrapper type(C_PTR), public :: cptr = C_NULL_PTR - integer(C_INT), public :: mem = SWIG_NULL + integer(C_INT), public :: cmemflags = 0 end type type, bind(C) :: SwigArrayWrapper type(C_PTR), public :: data = C_NULL_PTR @@ -116,14 +112,11 @@ module fortpetra type, public :: SWIGTYPE_Teuchos__RCPT_Kokkos__Compat__KokkosSerialWrapper9ZCDM type(SwigClassWrapper), public :: swigdata end type - type, public :: SWIGTYPE_Tpetra__MapT_LO_GO_NO_t - type(SwigClassWrapper), public :: swigdata - end type ! class Tpetra::Map< LO,GO,NO > type, public :: TpetraMap type(SwigClassWrapper), public :: swigdata contains - procedure :: release => delete_TpetraMap + procedure :: release => swigf_release_TpetraMap procedure :: isOneToOne => swigf_TpetraMap_isOneToOne procedure :: getGlobalNumElements => swigf_TpetraMap_getGlobalNumElements procedure :: getNodeNumElements => swigf_TpetraMap_getNodeNumElements @@ -168,14 +161,11 @@ module fortpetra type, public :: SWIGTYPE_std__ostream type(SwigClassWrapper), public :: swigdata end type - type, public :: SWIGTYPE_Tpetra__ImportT_LO_GO_NO_t - type(SwigClassWrapper), public :: swigdata - end type ! class Tpetra::Import< LO,GO,NO > type, public :: TpetraImport type(SwigClassWrapper), public :: swigdata contains - procedure :: release => delete_TpetraImport + procedure :: release => swigf_release_TpetraImport procedure :: setParameterList => swigf_TpetraImport_setParameterList procedure :: getNumSameIDs => swigf_TpetraImport_getNumSameIDs procedure :: getNumPermuteIDs => swigf_TpetraImport_getNumPermuteIDs @@ -198,14 +188,11 @@ module fortpetra module procedure swigf_new_TpetraImport__SWIG_2 module procedure swigf_new_TpetraImport__SWIG_3 end interface - type, public :: SWIGTYPE_Tpetra__ExportT_LO_GO_NO_t - type(SwigClassWrapper), public :: swigdata - end type ! class Tpetra::Export< LO,GO,NO > type, public :: TpetraExport type(SwigClassWrapper), public :: swigdata contains - procedure :: release => delete_TpetraExport + procedure :: release => swigf_release_TpetraExport procedure :: setParameterList => swigf_TpetraExport_setParameterList procedure :: getNumSameIDs => swigf_TpetraExport_getNumSameIDs procedure :: getNumPermuteIDs => swigf_TpetraExport_getNumPermuteIDs @@ -227,15 +214,12 @@ module fortpetra type, public :: SWIGTYPE_Kokkos__ViewT_double_p_Kokkos__HostSpace_t type(SwigClassWrapper), public :: swigdata end type - type, public :: SWIGTYPE_Tpetra__MultiVectorT_SC_LO_GO_NO_t - type(SwigClassWrapper), public :: swigdata - end type ! class Tpetra::MultiVector< SC,LO,GO,NO > type, public :: TpetraMultiVector type(SwigClassWrapper), public :: swigdata contains procedure :: swap => swigf_TpetraMultiVector_swap - procedure :: release => delete_TpetraMultiVector + procedure :: release => swigf_release_TpetraMultiVector procedure :: replaceGlobalValue => swigf_TpetraMultiVector_replaceGlobalValue procedure, private :: swigf_TpetraMultiVector_sumIntoGlobalValue__SWIG_0 procedure, private :: swigf_TpetraMultiVector_sumIntoGlobalValue__SWIG_1 @@ -321,14 +305,11 @@ module fortpetra module procedure swigf_new_TpetraMultiVector__SWIG_7 module procedure swigf_new_TpetraMultiVector__SWIG_8 end interface - type, public :: SWIGTYPE_Tpetra__OperatorT_SC_LO_GO_NO_t - type(SwigClassWrapper), public :: swigdata - end type ! class Tpetra::Operator< SC,LO,GO,NO > type, public :: TpetraOperator type(SwigClassWrapper), public :: swigdata contains - procedure :: release => delete_TpetraOperator + procedure :: release => swigf_release_TpetraOperator procedure, private :: swigf_TpetraOperator_op_assign__ generic :: assignment(=) => swigf_TpetraOperator_op_assign__ end type TpetraOperator @@ -340,12 +321,12 @@ module fortpetra procedure :: getDomainMap => swigf_ForTpetraOperator_getDomainMap procedure :: getRangeMap => swigf_ForTpetraOperator_getRangeMap procedure :: apply => swigf_ForTpetraOperator_apply - procedure :: release => delete_ForTpetraOperator + procedure :: release => swigf_release_ForTpetraOperator procedure, private :: swigf_ForTpetraOperator_op_assign__ generic :: assignment(=) => swigf_ForTpetraOperator_op_assign__ end type ForTpetraOperator interface ForTpetraOperator - module procedure new_ForTpetraOperator + module procedure swigf_create_ForTpetraOperator end interface type :: ForTpetraOperatorHandle @@ -367,12 +348,12 @@ module fortpetra procedure :: get_numEntries => swigf_RowInfo_numEntries_get procedure :: set_offset1D => swigf_RowInfo_offset1D_set procedure :: get_offset1D => swigf_RowInfo_offset1D_get - procedure :: release => delete_RowInfo + procedure :: release => swigf_release_RowInfo procedure, private :: swigf_RowInfo_op_assign__ generic :: assignment(=) => swigf_RowInfo_op_assign__ end type RowInfo interface RowInfo - module procedure new_RowInfo + module procedure swigf_create_RowInfo end interface ! enum Tpetra::ELocalGlobal enum, bind(c) @@ -381,14 +362,11 @@ module fortpetra end enum integer, parameter, public :: TpetraELocalGlobal = kind(TpetraLocalIndices) public :: TpetraLocalIndices, TpetraGlobalIndices - type, public :: SWIGTYPE_Tpetra__CrsGraphT_LO_GO_NO_t - type(SwigClassWrapper), public :: swigdata - end type ! class Tpetra::CrsGraph< LO,GO,NO > type, public :: TpetraCrsGraph type(SwigClassWrapper), public :: swigdata contains - procedure :: release => delete_TpetraCrsGraph + procedure :: release => swigf_release_TpetraCrsGraph procedure :: swap => swigf_TpetraCrsGraph_swap procedure :: isIdenticalTo => swigf_TpetraCrsGraph_isIdenticalTo procedure :: setParameterList => swigf_TpetraCrsGraph_setParameterList @@ -504,14 +482,11 @@ module fortpetra type, public :: SWIGTYPE_Teuchos__ArrayRCPT_unsigned_long_t type(SwigClassWrapper), public :: swigdata end type - type, public :: SWIGTYPE_Tpetra__CrsMatrixT_SC_LO_GO_NO_t - type(SwigClassWrapper), public :: swigdata - end type ! class Tpetra::CrsMatrix< SC,LO,GO,NO > type, public :: TpetraCrsMatrix type(SwigClassWrapper), public :: swigdata contains - procedure :: release => delete_TpetraCrsMatrix + procedure :: release => swigf_release_TpetraCrsMatrix procedure :: insertGlobalValues => swigf_TpetraCrsMatrix_insertGlobalValues procedure :: insertLocalValues => swigf_TpetraCrsMatrix_insertLocalValues procedure :: replaceGlobalValues => swigf_TpetraCrsMatrix_replaceGlobalValues @@ -632,9 +607,6 @@ module fortpetra end interface public :: operator_to_matrix public :: matrix_to_operator - type, public :: SWIGTYPE_Tpetra__MatrixMarket__ReaderT_Tpetra__CrsMatrixT_KG2R9 - type(SwigClassWrapper), public :: swigdata - end type ! class Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > > type, public :: TpetraReader type(SwigClassWrapper), public :: swigdata @@ -651,7 +623,7 @@ module fortpetra procedure, private, nopass :: swigf_TpetraReader_readSparseFile__SWIG_4 procedure, nopass :: readDenseFile => swigf_TpetraReader_readDenseFile procedure, nopass :: readMapFile => swigf_TpetraReader_readMapFile - procedure :: release => delete_TpetraReader + procedure :: release => swigf_release_TpetraReader procedure, private :: swigf_TpetraReader_op_assign__ generic :: assignment(=) => swigf_TpetraReader_op_assign__ generic :: readSparseGraphFile => swigf_TpetraReader_readSparseGraphFile__SWIG_0, & @@ -661,9 +633,6 @@ module fortpetra swigf_TpetraReader_readSparseFile__SWIG_2, swigf_TpetraReader_readSparseFile__SWIG_3, & swigf_TpetraReader_readSparseFile__SWIG_4 end type TpetraReader - type, public :: SWIGTYPE_Tpetra__MatrixMarket__WriterT_Tpetra__CrsMatrixT_KG2R9 - type(SwigClassWrapper), public :: swigdata - end type ! class Tpetra::MatrixMarket::Writer< Tpetra::CrsMatrix< SC,LO,GO,NO > > type, public :: TpetraWriter type(SwigClassWrapper), public :: swigdata @@ -674,7 +643,7 @@ module fortpetra procedure, private, nopass :: swigf_TpetraWriter_writeSparseGraphFile__SWIG_1 procedure, private, nopass :: swigf_TpetraWriter_writeDenseFile__SWIG_0 procedure, private, nopass :: swigf_TpetraWriter_writeDenseFile__SWIG_1 - procedure :: release => delete_TpetraWriter + procedure :: release => swigf_release_TpetraWriter procedure, private :: swigf_TpetraWriter_op_assign__ generic :: assignment(=) => swigf_TpetraWriter_op_assign__ generic :: writeSparseGraphFile => swigf_TpetraWriter_writeSparseGraphFile__SWIG_0, & @@ -4616,17 +4585,18 @@ function swigf_new_TpetraMap__SWIG_7() & self%swigdata = fresult end function -subroutine delete_TpetraMap(self) +subroutine swigf_release_TpetraMap(self) use, intrinsic :: ISO_C_BINDING class(TpetraMap), intent(inout) :: self type(SwigClassWrapper) :: farg1 farg1 = self%swigdata -if (self%swigdata%mem == SWIG_OWN) then +if (btest(farg1%cmemflags, swig_cmem_own_bit)) then call swigc_delete_TpetraMap(farg1) -end if -self%swigdata%cptr = C_NULL_PTR -self%swigdata%mem = SWIG_NULL +endif +farg1%cptr = C_NULL_PTR +farg1%cmemflags = 0 +self%swigdata = farg1 end subroutine @@ -5083,7 +5053,7 @@ function swigf_TpetraMap_replaceCommWithSubset(self, newcomm) & subroutine swigf_TpetraMap_op_assign__(self, other) use, intrinsic :: ISO_C_BINDING class(TpetraMap), intent(inout) :: self -type(SWIGTYPE_Tpetra__MapT_LO_GO_NO_t), intent(in) :: other +type(TpetraMap), intent(in) :: other type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 @@ -5154,17 +5124,18 @@ function swigf_new_TpetraImport__SWIG_3(exporter) & self%swigdata = fresult end function -subroutine delete_TpetraImport(self) +subroutine swigf_release_TpetraImport(self) use, intrinsic :: ISO_C_BINDING class(TpetraImport), intent(inout) :: self type(SwigClassWrapper) :: farg1 farg1 = self%swigdata -if (self%swigdata%mem == SWIG_OWN) then +if (btest(farg1%cmemflags, swig_cmem_own_bit)) then call swigc_delete_TpetraImport(farg1) -end if -self%swigdata%cptr = C_NULL_PTR -self%swigdata%mem = SWIG_NULL +endif +farg1%cptr = C_NULL_PTR +farg1%cmemflags = 0 +self%swigdata = farg1 end subroutine subroutine swigf_TpetraImport_setParameterList(self, plist) @@ -5330,7 +5301,7 @@ subroutine swigf_TpetraImport_print(self, os) subroutine swigf_TpetraImport_op_assign__(self, other) use, intrinsic :: ISO_C_BINDING class(TpetraImport), intent(inout) :: self -type(SWIGTYPE_Tpetra__ImportT_LO_GO_NO_t), intent(in) :: other +type(TpetraImport), intent(in) :: other type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 @@ -5401,17 +5372,18 @@ function swigf_new_TpetraExport__SWIG_3(importer) & self%swigdata = fresult end function -subroutine delete_TpetraExport(self) +subroutine swigf_release_TpetraExport(self) use, intrinsic :: ISO_C_BINDING class(TpetraExport), intent(inout) :: self type(SwigClassWrapper) :: farg1 farg1 = self%swigdata -if (self%swigdata%mem == SWIG_OWN) then +if (btest(farg1%cmemflags, swig_cmem_own_bit)) then call swigc_delete_TpetraExport(farg1) -end if -self%swigdata%cptr = C_NULL_PTR -self%swigdata%mem = SWIG_NULL +endif +farg1%cptr = C_NULL_PTR +farg1%cmemflags = 0 +self%swigdata = farg1 end subroutine subroutine swigf_TpetraExport_setParameterList(self, plist) @@ -5532,7 +5504,7 @@ subroutine swigf_TpetraExport_print(self, os) subroutine swigf_TpetraExport_op_assign__(self, other) use, intrinsic :: ISO_C_BINDING class(TpetraExport), intent(inout) :: self -type(SWIGTYPE_Tpetra__ExportT_LO_GO_NO_t), intent(in) :: other +type(TpetraExport), intent(in) :: other type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 @@ -5706,17 +5678,18 @@ subroutine swigf_TpetraMultiVector_swap(self, mv) call swigc_TpetraMultiVector_swap(farg1, farg2) end subroutine -subroutine delete_TpetraMultiVector(self) +subroutine swigf_release_TpetraMultiVector(self) use, intrinsic :: ISO_C_BINDING class(TpetraMultiVector), intent(inout) :: self type(SwigClassWrapper) :: farg1 farg1 = self%swigdata -if (self%swigdata%mem == SWIG_OWN) then +if (btest(farg1%cmemflags, swig_cmem_own_bit)) then call swigc_delete_TpetraMultiVector(farg1) -end if -self%swigdata%cptr = C_NULL_PTR -self%swigdata%mem = SWIG_NULL +endif +farg1%cptr = C_NULL_PTR +farg1%cmemflags = 0 +self%swigdata = farg1 end subroutine subroutine swigf_TpetraMultiVector_replaceGlobalValue(self, gblrow, col, value) @@ -6660,7 +6633,7 @@ subroutine swigf_TpetraMultiVector_doExport__SWIG_1(self, source, importer, cm) subroutine swigf_TpetraMultiVector_op_assign__(self, other) use, intrinsic :: ISO_C_BINDING class(TpetraMultiVector), intent(inout) :: self -type(SWIGTYPE_Tpetra__MultiVectorT_SC_LO_GO_NO_t), intent(in) :: other +type(TpetraMultiVector), intent(in) :: other type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 @@ -6670,23 +6643,24 @@ subroutine swigf_TpetraMultiVector_op_assign__(self, other) self%swigdata = farg1 end subroutine -subroutine delete_TpetraOperator(self) +subroutine swigf_release_TpetraOperator(self) use, intrinsic :: ISO_C_BINDING class(TpetraOperator), intent(inout) :: self type(SwigClassWrapper) :: farg1 farg1 = self%swigdata -if (self%swigdata%mem == SWIG_OWN) then +if (btest(farg1%cmemflags, swig_cmem_own_bit)) then call swigc_delete_TpetraOperator(farg1) -end if -self%swigdata%cptr = C_NULL_PTR -self%swigdata%mem = SWIG_NULL +endif +farg1%cptr = C_NULL_PTR +farg1%cmemflags = 0 +self%swigdata = farg1 end subroutine subroutine swigf_TpetraOperator_op_assign__(self, other) use, intrinsic :: ISO_C_BINDING class(TpetraOperator), intent(inout) :: self -type(SWIGTYPE_Tpetra__OperatorT_SC_LO_GO_NO_t), intent(in) :: other +type(TpetraOperator), intent(in) :: other type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 @@ -6721,7 +6695,7 @@ subroutine swigf_ForTpetraOperator_init(self, fh) call swigc_ForTpetraOperator_init(farg1, farg2) end subroutine -function new_ForTpetraOperator() & +function swigf_create_ForTpetraOperator() & result(self) use, intrinsic :: ISO_C_BINDING type(ForTpetraOperator) :: self @@ -6781,7 +6755,7 @@ subroutine swigf_ForTpetraOperator_apply(self, x, y, mode, alpha, beta) call swigc_ForTpetraOperator_apply(farg1, farg2, farg3, farg4, farg5, farg6) end subroutine -subroutine delete_ForTpetraOperator(self) +subroutine swigf_release_ForTpetraOperator(self) use, intrinsic :: ISO_C_BINDING class(ForTpetraOperator), intent(inout) :: self type(SwigClassWrapper) :: farg1 @@ -6792,11 +6766,12 @@ subroutine delete_ForTpetraOperator(self) fself_ptr = swigc_ForTpetraOperator_fhandle(self%swigdata) call c_f_pointer(cptr=fself_ptr, fptr=handle) farg1 = self%swigdata -if (self%swigdata%mem == SWIG_OWN) then +if (btest(farg1%cmemflags, swig_cmem_own_bit)) then call swigc_delete_ForTpetraOperator(farg1) -end if -self%swigdata%cptr = C_NULL_PTR -self%swigdata%mem = SWIG_NULL +endif +farg1%cptr = C_NULL_PTR +farg1%cmemflags = 0 +self%swigdata = farg1 ! Release the allocated handle deallocate(handle) @@ -7023,7 +6998,7 @@ function swigf_RowInfo_offset1D_get(self) & swig_result = fresult end function -function new_RowInfo() & +function swigf_create_RowInfo() & result(self) use, intrinsic :: ISO_C_BINDING type(RowInfo) :: self @@ -7033,17 +7008,18 @@ function new_RowInfo() & self%swigdata = fresult end function -subroutine delete_RowInfo(self) +subroutine swigf_release_RowInfo(self) use, intrinsic :: ISO_C_BINDING class(RowInfo), intent(inout) :: self type(SwigClassWrapper) :: farg1 farg1 = self%swigdata -if (self%swigdata%mem == SWIG_OWN) then +if (btest(farg1%cmemflags, swig_cmem_own_bit)) then call swigc_delete_RowInfo(farg1) -end if -self%swigdata%cptr = C_NULL_PTR -self%swigdata%mem = SWIG_NULL +endif +farg1%cptr = C_NULL_PTR +farg1%cmemflags = 0 +self%swigdata = farg1 end subroutine subroutine swigf_RowInfo_op_assign__(self, other) @@ -7432,17 +7408,18 @@ function swigf_new_TpetraCrsGraph__SWIG_13(rowmap, colmap, rowpointers, columnin self%swigdata = fresult end function -subroutine delete_TpetraCrsGraph(self) +subroutine swigf_release_TpetraCrsGraph(self) use, intrinsic :: ISO_C_BINDING class(TpetraCrsGraph), intent(inout) :: self type(SwigClassWrapper) :: farg1 farg1 = self%swigdata -if (self%swigdata%mem == SWIG_OWN) then +if (btest(farg1%cmemflags, swig_cmem_own_bit)) then call swigc_delete_TpetraCrsGraph(farg1) -end if -self%swigdata%cptr = C_NULL_PTR -self%swigdata%mem = SWIG_NULL +endif +farg1%cptr = C_NULL_PTR +farg1%cmemflags = 0 +self%swigdata = farg1 end subroutine subroutine swigf_TpetraCrsGraph_swap(self, graph) @@ -8594,7 +8571,7 @@ subroutine swigf_TpetraCrsGraph_doExport__SWIG_1(self, source, importer, cm) subroutine swigf_TpetraCrsGraph_op_assign__(self, other) use, intrinsic :: ISO_C_BINDING class(TpetraCrsGraph), intent(inout) :: self -type(SWIGTYPE_Tpetra__CrsGraphT_LO_GO_NO_t), intent(in) :: other +type(TpetraCrsGraph), intent(in) :: other type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 @@ -9063,17 +9040,18 @@ function swigf_new_TpetraCrsMatrix__SWIG_17(rowmap, colmap, rowpointers, columni self%swigdata = fresult end function -subroutine delete_TpetraCrsMatrix(self) +subroutine swigf_release_TpetraCrsMatrix(self) use, intrinsic :: ISO_C_BINDING class(TpetraCrsMatrix), intent(inout) :: self type(SwigClassWrapper) :: farg1 farg1 = self%swigdata -if (self%swigdata%mem == SWIG_OWN) then +if (btest(farg1%cmemflags, swig_cmem_own_bit)) then call swigc_delete_TpetraCrsMatrix(farg1) -end if -self%swigdata%cptr = C_NULL_PTR -self%swigdata%mem = SWIG_NULL +endif +farg1%cptr = C_NULL_PTR +farg1%cmemflags = 0 +self%swigdata = farg1 end subroutine subroutine swigf_TpetraCrsMatrix_insertGlobalValues(self, globalrow, cols, vals) @@ -10520,7 +10498,7 @@ subroutine swigf_TpetraCrsMatrix_getAllValues(self, rowpointers, columnindices, subroutine swigf_TpetraCrsMatrix_op_assign__(self, other) use, intrinsic :: ISO_C_BINDING class(TpetraCrsMatrix), intent(inout) :: self -type(SWIGTYPE_Tpetra__CrsMatrixT_SC_LO_GO_NO_t), intent(in) :: other +type(TpetraCrsMatrix), intent(in) :: other type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 @@ -10823,23 +10801,24 @@ function swigf_TpetraReader_readMapFile(filename, comm) & swig_result%swigdata = fresult end function -subroutine delete_TpetraReader(self) +subroutine swigf_release_TpetraReader(self) use, intrinsic :: ISO_C_BINDING class(TpetraReader), intent(inout) :: self type(SwigClassWrapper) :: farg1 farg1 = self%swigdata -if (self%swigdata%mem == SWIG_OWN) then +if (btest(farg1%cmemflags, swig_cmem_own_bit)) then call swigc_delete_TpetraReader(farg1) -end if -self%swigdata%cptr = C_NULL_PTR -self%swigdata%mem = SWIG_NULL +endif +farg1%cptr = C_NULL_PTR +farg1%cmemflags = 0 +self%swigdata = farg1 end subroutine subroutine swigf_TpetraReader_op_assign__(self, other) use, intrinsic :: ISO_C_BINDING class(TpetraReader), intent(inout) :: self -type(SWIGTYPE_Tpetra__MatrixMarket__ReaderT_Tpetra__CrsMatrixT_KG2R9), intent(in) :: other +type(TpetraReader), intent(in) :: other type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 @@ -10951,23 +10930,24 @@ subroutine swigf_TpetraWriter_writeDenseFile__SWIG_1(filename, x) call swigc_TpetraWriter_writeDenseFile__SWIG_1(farg1, farg2) end subroutine -subroutine delete_TpetraWriter(self) +subroutine swigf_release_TpetraWriter(self) use, intrinsic :: ISO_C_BINDING class(TpetraWriter), intent(inout) :: self type(SwigClassWrapper) :: farg1 farg1 = self%swigdata -if (self%swigdata%mem == SWIG_OWN) then +if (btest(farg1%cmemflags, swig_cmem_own_bit)) then call swigc_delete_TpetraWriter(farg1) -end if -self%swigdata%cptr = C_NULL_PTR -self%swigdata%mem = SWIG_NULL +endif +farg1%cptr = C_NULL_PTR +farg1%cmemflags = 0 +self%swigdata = farg1 end subroutine subroutine swigf_TpetraWriter_op_assign__(self, other) use, intrinsic :: ISO_C_BINDING class(TpetraWriter), intent(inout) :: self -type(SWIGTYPE_Tpetra__MatrixMarket__WriterT_Tpetra__CrsMatrixT_KG2R9), intent(in) :: other +type(TpetraWriter), intent(in) :: other type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 diff --git a/src/tpetra/src/swig/fortpetraFORTRAN_wrap.cxx b/src/tpetra/src/swig/fortpetraFORTRAN_wrap.cxx index a01f14d6..9a14e385 100644 --- a/src/tpetra/src/swig/fortpetraFORTRAN_wrap.cxx +++ b/src/tpetra/src/swig/fortpetraFORTRAN_wrap.cxx @@ -205,6 +205,13 @@ void SWIG_store_exception(const char* decl, int errcode, const char *msg); SWIG_store_exception(DECL, CODE, MSG); RETURNNULL; +enum SwigMemFlags { + SWIG_MEM_OWN = 0x01, + SWIG_MEM_RVALUE = 0x02, + SWIG_MEM_CONST = 0x04 +}; + + #define SWIG_check_sp_nonnull(INPUT, TYPENAME, FNAME, FUNCNAME, RETURNNULL) \ if (!(INPUT)) { \ SWIG_exception_impl(FUNCNAME, SWIG_TypeError, \ @@ -212,9 +219,13 @@ void SWIG_store_exception(const char* decl, int errcode, const char *msg); "as a reference", RETURNNULL); \ } +#define SWIG_constsp_mem_flags SWIG_MEM_CONST +#define SWIG_sp_mem_flags 0 + + #define SWIG_check_nonnull(SWIG_CLASS_WRAPPER, TYPENAME, FNAME, FUNCNAME, RETURNNULL) \ - if ((SWIG_CLASS_WRAPPER).mem == SWIG_NULL) { \ + if (!(SWIG_CLASS_WRAPPER).cptr) { \ SWIG_exception_impl(FUNCNAME, SWIG_TypeError, \ "Cannot pass null " TYPENAME " (class " FNAME ") " \ "as a reference", RETURNNULL); \ @@ -222,26 +233,16 @@ void SWIG_store_exception(const char* decl, int errcode, const char *msg); namespace swig { - -enum AssignmentFlags { - IS_DESTR = 0x01, - IS_COPY_CONSTR = 0x02, - IS_COPY_ASSIGN = 0x04, - IS_MOVE_CONSTR = 0x08, - IS_MOVE_ASSIGN = 0x10 +enum AssignmentType { + ASSIGNMENT_DEFAULT, + ASSIGNMENT_NODESTRUCT, + ASSIGNMENT_SMARTPTR }; - -template -struct assignment_flags; } -#define SWIG_assign(LEFTTYPE, LEFT, RIGHTTYPE, RIGHT, FLAGS) \ - SWIG_assign_impl::value >(LEFT, RIGHT); - - #define SWIG_check_mutable(SWIG_CLASS_WRAPPER, TYPENAME, FNAME, FUNCNAME, RETURNNULL) \ - if ((SWIG_CLASS_WRAPPER).mem == SWIG_CREF) { \ + if ((SWIG_CLASS_WRAPPER).cmemflags & SWIG_MEM_CONST) { \ SWIG_exception_impl(FUNCNAME, SWIG_TypeError, \ "Cannot pass const " TYPENAME " (class " FNAME ") " \ "as a mutable reference", \ @@ -253,6 +254,17 @@ struct assignment_flags; SWIG_check_nonnull(SWIG_CLASS_WRAPPER, TYPENAME, FNAME, FUNCNAME, RETURNNULL); \ SWIG_check_mutable(SWIG_CLASS_WRAPPER, TYPENAME, FNAME, FUNCNAME, RETURNNULL); +#define SWIGPOLICY_Tpetra__MapT_int_long_long_Kokkos__Compat__KokkosSerialWrapperNode_t swig::ASSIGNMENT_SMARTPTR +#define SWIGPOLICY_Tpetra__ImportT_int_long_long_Kokkos__Compat__KokkosSerialWrapperNode_t swig::ASSIGNMENT_SMARTPTR +#define SWIGPOLICY_Tpetra__ExportT_int_long_long_Kokkos__Compat__KokkosSerialWrapperNode_t swig::ASSIGNMENT_SMARTPTR +#define SWIGPOLICY_Tpetra__MultiVectorT_double_int_long_long_Kokkos__Compat__KokkosSerialWrapperNode_t swig::ASSIGNMENT_SMARTPTR +#define SWIGPOLICY_Tpetra__OperatorT_double_int_long_long_Kokkos__Compat__KokkosSerialWrapperNode_t swig::ASSIGNMENT_SMARTPTR +#define SWIGPOLICY_ForTpetraOperator swig::ASSIGNMENT_SMARTPTR +#define SWIGPOLICY_Tpetra__RowInfo swig::ASSIGNMENT_DEFAULT +#define SWIGPOLICY_Tpetra__CrsGraphT_int_long_long_Kokkos__Compat__KokkosSerialWrapperNode_t swig::ASSIGNMENT_SMARTPTR +#define SWIGPOLICY_Tpetra__CrsMatrixT_double_int_long_long_Kokkos__Compat__KokkosSerialWrapperNode_t swig::ASSIGNMENT_SMARTPTR +#define SWIGPOLICY_Tpetra__MatrixMarket__ReaderT_Tpetra__CrsMatrixT_SC_LO_GO_NO_t_t swig::ASSIGNMENT_SMARTPTR +#define SWIGPOLICY_Tpetra__MatrixMarket__WriterT_Tpetra__CrsMatrixT_SC_LO_GO_NO_t_t swig::ASSIGNMENT_SMARTPTR #include @@ -290,25 +302,16 @@ typedef char Packet; #include "Tpetra_CombineMode.hpp" -enum SwigMemState { - SWIG_NULL, - SWIG_OWN, - SWIG_MOVE, - SWIG_REF, - SWIG_CREF -}; - - struct SwigClassWrapper { void* cptr; - SwigMemState mem; + int cmemflags; }; SWIGINTERN SwigClassWrapper SwigClassWrapper_uninitialized() { SwigClassWrapper result; result.cptr = NULL; - result.mem = SWIG_NULL; + result.cmemflags = 0; return result; } @@ -351,229 +354,107 @@ SWIGINTERN SwigArrayWrapper SwigArrayWrapper_uninitialized() { #define SWIG_NO_NULL_DELETER_SWIG_POINTER_OWN -#include - - namespace swig { -// Define our own switching struct to support pre-c++11 builds -template -struct bool_constant {}; -typedef bool_constant true_type; -typedef bool_constant false_type; - -// Deletion -template -SWIGINTERN void destruct_impl(T* self, true_type) { - delete self; -} -template -SWIGINTERN T* destruct_impl(T* , false_type) { - SWIG_exception_impl("assignment", SWIG_TypeError, - "Invalid assignment: class type has no destructor", - return NULL); -} - -// Copy construction and assignment -template -SWIGINTERN T* copy_construct_impl(const U* other, true_type) { - return new T(*other); -} -template -SWIGINTERN void copy_assign_impl(T* self, const U* other, true_type) { - *self = *other; -} - -// Disabled construction and assignment -template -SWIGINTERN T* copy_construct_impl(const U* , false_type) { - SWIG_exception_impl("assignment", SWIG_TypeError, - "Invalid assignment: class type has no copy constructor", - return NULL); -} -template -SWIGINTERN void copy_assign_impl(T* , const U* , false_type) { - SWIG_exception_impl("assignment", SWIG_TypeError, - "Invalid assignment: class type has no copy assignment", - return); -} - -#if __cplusplus >= 201103L -#include -#include - -// Move construction and assignment -template -SWIGINTERN T* move_construct_impl(U* other, true_type) { - return new T(std::move(*other)); -} -template -SWIGINTERN void move_assign_impl(T* self, U* other, true_type) { - *self = std::move(*other); -} - -// Disabled move construction and assignment -template -SWIGINTERN T* move_construct_impl(U*, false_type) { - SWIG_exception_impl("assignment", SWIG_TypeError, - "Invalid assignment: class type has no move constructor", - return NULL); -} -template -SWIGINTERN void move_assign_impl(T*, U*, false_type) { - SWIG_exception_impl("assignment", SWIG_TypeError, - "Invalid assignment: class type has no move assignment", - return); -} - -template -struct assignment_flags { - constexpr static int value = - (std::is_destructible::value ? IS_DESTR : 0) - | (std::is_copy_constructible::value ? IS_COPY_CONSTR : 0) - | (std::is_copy_assignable::value ? IS_COPY_ASSIGN : 0) - | (std::is_move_constructible::value ? IS_MOVE_CONSTR : 0) - | (std::is_move_assignable::value ? IS_MOVE_ASSIGN : 0); +template +struct DestructorPolicy { + static SwigClassWrapper destruct(SwigClassWrapper self) { + delete static_cast(self.cptr); + return SwigClassWrapper_uninitialized(); + } }; - -#else - -template -struct assignment_flags { - enum { value = Flags }; +template +struct DestructorPolicy { + static SwigClassWrapper destruct(SwigClassWrapper self) { + SWIG_exception_impl("assignment", SWIG_TypeError, "Invalid assignment: class type has private destructor", return SwigClassWrapper_uninitialized()); + } }; +} -#endif -template -struct AssignmentTraits { - static void destruct(T* self) { - destruct_impl(self, bool_constant()); - } +namespace swig { - template - static T* copy_construct(const U* other) { - return copy_construct_impl(other, bool_constant()); +template +struct AssignmentPolicy { + static SwigClassWrapper destruct(SwigClassWrapper self) { + return DestructorPolicy::destruct(self); } - - template - static void copy_assign(T* self, const U* other) { - copy_assign_impl(self, other, bool_constant()); + static SwigClassWrapper alias(SwigClassWrapper other) { + SwigClassWrapper self; + self.cptr = other.cptr; + self.cmemflags = other.cmemflags & ~SWIG_MEM_OWN; + return self; } - -#if __cplusplus >= 201103L - template - static T* move_construct(U* other) { - return move_construct_impl(other, bool_constant()); - } - template - static void move_assign(T* self, U* other) { - move_assign_impl(self, other, bool_constant()); + static SwigClassWrapper move_alias(SwigClassWrapper self, SwigClassWrapper other) { + if (self.cmemflags & SWIG_MEM_OWN) { + destruct(self); + } + self.cptr = other.cptr; + self.cmemflags = other.cmemflags & ~SWIG_MEM_RVALUE; + return self; } -#else - template - static T* move_construct(U* other) { - return copy_construct_impl(other, bool_constant()); + static SwigClassWrapper copy_alias(SwigClassWrapper self, SwigClassWrapper other) { + if (self.cmemflags & SWIG_MEM_OWN) { + destruct(self); + } + self.cptr = other.cptr; + self.cmemflags = other.cmemflags & ~SWIG_MEM_OWN; + return self; } - template - static void move_assign(T* self, U* other) { - copy_assign_impl(self, other, bool_constant()); +}; + +template +struct AssignmentPolicy { + static SwigClassWrapper destruct(SwigClassWrapper self) { + return DestructorPolicy::destruct(self); + } + static SwigClassWrapper alias(SwigClassWrapper other) { + SwigClassWrapper self; + self.cptr = new T(*static_cast(other.cptr)); + self.cmemflags = other.cmemflags | SWIG_MEM_OWN; + return self; + } + static SwigClassWrapper move_alias(SwigClassWrapper self, SwigClassWrapper other) { + self = copy_alias(self, other); + self.cmemflags = other.cmemflags & ~SWIG_MEM_RVALUE; + destruct(other); + return self; + } + static SwigClassWrapper copy_alias(SwigClassWrapper self, SwigClassWrapper other) { + // LHS and RHS should both 'own' their shared pointers + T *pself = static_cast(self.cptr); + T *pother = static_cast(other.cptr); + *pself = *pother; + return self; } -#endif }; } // end namespace swig - -template -SWIGINTERN void SWIG_assign_impl(SwigClassWrapper* self, const SwigClassWrapper* other) { - typedef swig::AssignmentTraits Traits_t; - T1* pself = static_cast(self->cptr); - T2* pother = static_cast(other->cptr); - - switch (self->mem) { - case SWIG_NULL: - /* LHS is unassigned */ - switch (other->mem) { - case SWIG_NULL: /* null op */ - break; - case SWIG_MOVE: /* capture pointer from RHS */ - self->cptr = other->cptr; - self->mem = SWIG_OWN; - break; - case SWIG_OWN: /* copy from RHS */ - self->cptr = Traits_t::copy_construct(pother); - self->mem = SWIG_OWN; - break; - case SWIG_REF: /* pointer to RHS */ - case SWIG_CREF: - self->cptr = other->cptr; - self->mem = other->mem; - break; - } - break; - case SWIG_OWN: - /* LHS owns memory */ - switch (other->mem) { - case SWIG_NULL: - /* Delete LHS */ - Traits_t::destruct(pself); - self->cptr = NULL; - self->mem = SWIG_NULL; - break; - case SWIG_MOVE: - /* Move RHS into LHS; delete RHS */ - Traits_t::move_assign(pself, pother); - Traits_t::destruct(pother); - break; - case SWIG_OWN: - case SWIG_REF: - case SWIG_CREF: - /* Copy RHS to LHS */ - Traits_t::copy_assign(pself, pother); - break; - } - break; - case SWIG_MOVE: - SWIG_exception_impl("assignment", SWIG_RuntimeError, - "Left-hand side of assignment should never be in a 'MOVE' state", - return); - break; - case SWIG_REF: - /* LHS is a reference */ - switch (other->mem) { - case SWIG_NULL: - /* Remove LHS reference */ - self->cptr = NULL; - self->mem = SWIG_NULL; - break; - case SWIG_MOVE: - /* Move RHS into LHS; delete RHS. The original ownership stays the - * same. */ - Traits_t::move_assign(pself, pother); - Traits_t::destruct(pother); - break; - case SWIG_OWN: - case SWIG_REF: - case SWIG_CREF: - /* Copy RHS to LHS */ - Traits_t::copy_assign(pself, pother); - break; - } - break; - case SWIG_CREF: - switch (other->mem) { - case SWIG_NULL: - /* Remove LHS reference */ - self->cptr = NULL; - self->mem = SWIG_NULL; - break; - default: - SWIG_exception_impl("assignment", SWIG_RuntimeError, - "Cannot assign to a const reference", return); - break; - } - break; +template +SWIGINTERN void SWIG_assign(SwigClassWrapper* self, SwigClassWrapper other) { + typedef swig::AssignmentPolicy Policy_t; + + if (self->cptr == NULL) { + /* LHS is unassigned */ + if (other.cmemflags & SWIG_MEM_RVALUE) { + /* Capture pointer from RHS, clear 'moving' flag */ + self->cptr = other.cptr; + self->cmemflags = other.cmemflags & (~SWIG_MEM_RVALUE); + } else { + /* Aliasing another class; clear ownership or copy smart pointer */ + *self = Policy_t::alias(other); + } + } else if (other.cptr == NULL) { + /* Replace LHS with a null pointer */ + *self = Policy_t::destruct(*self); + } else if (other.cmemflags & SWIG_MEM_RVALUE) { + /* Transferred ownership from a variable that's about to be lost. + * Move-assign and delete the transient data */ + *self = Policy_t::move_alias(*self, other); + } else { + /* RHS shouldn't be deleted, alias to LHS */ + *self = Policy_t::copy_alias(*self, other); } } @@ -642,7 +523,7 @@ SwigClassWrapper swigd_ForTpetraOperator_getRangeMap( const_cast(this) SWIG_NO_NULL_DELETER_0); SwigClassWrapper self; self.cptr = &tempthis; - self.mem = SWIG_CREF; // since this function is const + self.cmemflags = SWIG_MEM_CONST; SwigClassWrapper fresult = swigd_ForTpetraOperator_getDomainMap(&self); @@ -656,7 +537,7 @@ SwigClassWrapper swigd_ForTpetraOperator_getRangeMap( const_cast(this) SWIG_NO_NULL_DELETER_0); SwigClassWrapper self; self.cptr = &tempthis; - self.mem = SWIG_CREF; // since this function is const + self.cmemflags = SWIG_MEM_CONST; SwigClassWrapper fresult = swigd_ForTpetraOperator_getRangeMap(&self); @@ -672,20 +553,20 @@ SwigClassWrapper swigd_ForTpetraOperator_getRangeMap( const_cast(this) SWIG_NO_NULL_DELETER_0); SwigClassWrapper self; self.cptr = &tempthis; - self.mem = SWIG_CREF; // since this function is const + self.cmemflags = SWIG_MEM_CONST; /* convert X -> class wrapper */ Teuchos::RCP > temprcp1(&X SWIG_NO_NULL_DELETER_0); SwigClassWrapper farg1; farg1.cptr = &temprcp1; - farg1.mem = SWIG_CREF; // X is const + farg1.cmemflags = SWIG_MEM_CONST; Teuchos::RCP< Tpetra::MultiVector > temprcp2(&Y SWIG_NO_NULL_DELETER_0); SwigClassWrapper farg2; farg2.cptr = &temprcp2; - farg2.mem = SWIG_REF; // Y is mutable + farg2.cmemflags = 0; /* convert scalars to wrappers */ int farg3 = mode; @@ -772,9 +653,7 @@ namespace ForTrilinos { #include "Teuchos_RCP.hpp" #include "TpetraExt_MatrixMatrix.hpp" -#ifdef __cplusplus extern "C" { -#endif SWIGEXPORT void _wrap_setCombineModeParameter(SwigClassWrapper const *farg1, SwigArrayWrapper *farg2) { Teuchos::ParameterList *arg1 = 0 ; std::string *arg2 = 0 ; @@ -894,7 +773,7 @@ SWIGEXPORT SwigClassWrapper _wrap_new_TpetraMap__SWIG_0(long const *farg1, SwigC } } fresult.cptr = result ? new Teuchos::RCP< Tpetra::Map >(result SWIG_NO_NULL_DELETER_1) : NULL; - fresult.mem = SWIG_MOVE; + fresult.cmemflags = SWIG_MEM_OWN | SWIG_MEM_RVALUE | SWIG_sp_mem_flags; return fresult; } @@ -938,7 +817,7 @@ SWIGEXPORT SwigClassWrapper _wrap_new_TpetraMap__SWIG_1(long const *farg1, SwigC } } fresult.cptr = result ? new Teuchos::RCP< Tpetra::Map >(result SWIG_NO_NULL_DELETER_1) : NULL; - fresult.mem = SWIG_MOVE; + fresult.cmemflags = SWIG_MEM_OWN | SWIG_MEM_RVALUE | SWIG_sp_mem_flags; return fresult; } @@ -980,7 +859,7 @@ SWIGEXPORT SwigClassWrapper _wrap_new_TpetraMap__SWIG_2(long const *farg1, SwigC } } fresult.cptr = result ? new Teuchos::RCP< Tpetra::Map >(result SWIG_NO_NULL_DELETER_1) : NULL; - fresult.mem = SWIG_MOVE; + fresult.cmemflags = SWIG_MEM_OWN | SWIG_MEM_RVALUE | SWIG_sp_mem_flags; return fresult; } @@ -1027,7 +906,7 @@ SWIGEXPORT SwigClassWrapper _wrap_new_TpetraMap__SWIG_3(long const *farg1, int c } } fresult.cptr = result ? new Teuchos::RCP< Tpetra::Map >(result SWIG_NO_NULL_DELETER_1) : NULL; - fresult.mem = SWIG_MOVE; + fresult.cmemflags = SWIG_MEM_OWN | SWIG_MEM_RVALUE | SWIG_sp_mem_flags; return fresult; } @@ -1071,7 +950,7 @@ SWIGEXPORT SwigClassWrapper _wrap_new_TpetraMap__SWIG_4(long const *farg1, int c } } fresult.cptr = result ? new Teuchos::RCP< Tpetra::Map >(result SWIG_NO_NULL_DELETER_1) : NULL; - fresult.mem = SWIG_MOVE; + fresult.cmemflags = SWIG_MEM_OWN | SWIG_MEM_RVALUE | SWIG_sp_mem_flags; return fresult; } @@ -1120,7 +999,7 @@ SWIGEXPORT SwigClassWrapper _wrap_new_TpetraMap__SWIG_5(long const *farg1, SwigA } } fresult.cptr = result ? new Teuchos::RCP< Tpetra::Map >(result SWIG_NO_NULL_DELETER_1) : NULL; - fresult.mem = SWIG_MOVE; + fresult.cmemflags = SWIG_MEM_OWN | SWIG_MEM_RVALUE | SWIG_sp_mem_flags; return fresult; } @@ -1166,7 +1045,7 @@ SWIGEXPORT SwigClassWrapper _wrap_new_TpetraMap__SWIG_6(long const *farg1, SwigA } } fresult.cptr = result ? new Teuchos::RCP< Tpetra::Map >(result SWIG_NO_NULL_DELETER_1) : NULL; - fresult.mem = SWIG_MOVE; + fresult.cmemflags = SWIG_MEM_OWN | SWIG_MEM_RVALUE | SWIG_sp_mem_flags; return fresult; } @@ -1199,7 +1078,7 @@ SWIGEXPORT SwigClassWrapper _wrap_new_TpetraMap__SWIG_7() { } } fresult.cptr = result ? new Teuchos::RCP< Tpetra::Map >(result SWIG_NO_NULL_DELETER_1) : NULL; - fresult.mem = SWIG_MOVE; + fresult.cmemflags = SWIG_MEM_OWN | SWIG_MEM_RVALUE | SWIG_sp_mem_flags; return fresult; } @@ -2151,7 +2030,7 @@ SWIGEXPORT SwigClassWrapper _wrap_TpetraMap_getComm(SwigClassWrapper const *farg } } fresult.cptr = (new Teuchos::RCP >(static_cast< const Teuchos::RCP >& >(result))); - fresult.mem = SWIG_MOVE; + fresult.cmemflags = SWIG_MEM_OWN | SWIG_MEM_RVALUE | SWIG_constsp_mem_flags; return fresult; } @@ -2230,7 +2109,7 @@ SWIGEXPORT SwigClassWrapper _wrap_TpetraMap_removeEmptyProcesses(SwigClassWrappe } } fresult.cptr = (new Teuchos::RCP >(static_cast< const Teuchos::RCP >& >(result))); - fresult.mem = SWIG_MOVE; + fresult.cmemflags = SWIG_MEM_OWN | SWIG_MEM_RVALUE | SWIG_constsp_mem_flags; return fresult; } @@ -2270,7 +2149,7 @@ SWIGEXPORT SwigClassWrapper _wrap_TpetraMap_replaceCommWithSubset(SwigClassWrapp } } fresult.cptr = (new Teuchos::RCP >(static_cast< const Teuchos::RCP >& >(result))); - fresult.mem = SWIG_MOVE; + fresult.cmemflags = SWIG_MEM_OWN | SWIG_MEM_RVALUE | SWIG_constsp_mem_flags; return fresult; } @@ -2279,34 +2158,15 @@ SWIGEXPORT void _wrap_TpetraMap_op_assign__(SwigClassWrapper *farg1, SwigClassWr Tpetra::Map< LO,GO,NO > *arg1 = (Tpetra::Map< LO,GO,NO > *) 0 ; Tpetra::Map< LO,GO,NO > *arg2 = 0 ; Teuchos::RCP< Tpetra::Map< LO,GO,NO > > *smartarg1 ; + Teuchos::RCP< Tpetra::Map< LO,GO,NO > > *smartarg2 ; smartarg1 = static_cast< Teuchos::RCP< Tpetra::Map >* >(farg1->cptr); arg1 = smartarg1 ? const_cast< Tpetra::Map* >(smartarg1->get()) : NULL; - (void)sizeof(arg2); - { - // Make sure no unhandled exceptions exist before performing a new action - SWIG_check_unhandled_exception_impl("Tpetra::Map< LO,GO,NO >::operator =(Tpetra::Map< LO,GO,NO > const &)");; - try - { - // Attempt the wrapped function call - typedef Teuchos::RCP< Tpetra::Map > swig_lhs_classtype; - SWIG_assign(swig_lhs_classtype, farg1, swig_lhs_classtype, farg2, 0 | swig::IS_DESTR | swig::IS_COPY_CONSTR); - } - catch (const std::range_error& e) - { - // Store a C++ exception - SWIG_exception_impl("Tpetra::Map< LO,GO,NO >::operator =(Tpetra::Map< LO,GO,NO > const &)", SWIG_IndexError, e.what(), return ); - } - catch (const std::exception& e) - { - // Store a C++ exception - SWIG_exception_impl("Tpetra::Map< LO,GO,NO >::operator =(Tpetra::Map< LO,GO,NO > const &)", SWIG_RuntimeError, e.what(), return ); - } - catch (...) - { - SWIG_exception_impl("Tpetra::Map< LO,GO,NO >::operator =(Tpetra::Map< LO,GO,NO > const &)", SWIG_UnknownError, "An unknown exception occurred", return ); - } - } + SWIG_check_sp_nonnull(farg2, "Tpetra::Map< LO,GO,NO > *", "TpetraMap", "Tpetra::Map< LO,GO,NO >::operator =(Tpetra::Map< LO,GO,NO > &)", return ) + smartarg2 = static_cast< Teuchos::RCP< Tpetra::Map >* >(farg2->cptr); + arg2 = const_cast< Tpetra::Map* >(smartarg2->get()); + SWIG_assign >, SWIGPOLICY_Tpetra__MapT_int_long_long_Kokkos__Compat__KokkosSerialWrapperNode_t>(farg1, *farg2); + } @@ -2344,7 +2204,7 @@ SWIGEXPORT SwigClassWrapper _wrap_new_TpetraImport__SWIG_0(SwigClassWrapper cons } } fresult.cptr = result ? new Teuchos::RCP< Tpetra::Import >(result SWIG_NO_NULL_DELETER_1) : NULL; - fresult.mem = SWIG_MOVE; + fresult.cmemflags = SWIG_MEM_OWN | SWIG_MEM_RVALUE | SWIG_sp_mem_flags; return fresult; } @@ -2386,7 +2246,7 @@ SWIGEXPORT SwigClassWrapper _wrap_new_TpetraImport__SWIG_1(SwigClassWrapper cons } } fresult.cptr = result ? new Teuchos::RCP< Tpetra::Import >(result SWIG_NO_NULL_DELETER_1) : NULL; - fresult.mem = SWIG_MOVE; + fresult.cmemflags = SWIG_MEM_OWN | SWIG_MEM_RVALUE | SWIG_sp_mem_flags; return fresult; } @@ -2424,7 +2284,7 @@ SWIGEXPORT SwigClassWrapper _wrap_new_TpetraImport__SWIG_2(SwigClassWrapper cons } } fresult.cptr = result ? new Teuchos::RCP< Tpetra::Import >(result SWIG_NO_NULL_DELETER_1) : NULL; - fresult.mem = SWIG_MOVE; + fresult.cmemflags = SWIG_MEM_OWN | SWIG_MEM_RVALUE | SWIG_sp_mem_flags; return fresult; } @@ -2462,7 +2322,7 @@ SWIGEXPORT SwigClassWrapper _wrap_new_TpetraImport__SWIG_3(SwigClassWrapper cons } } fresult.cptr = result ? new Teuchos::RCP< Tpetra::Import >(result SWIG_NO_NULL_DELETER_1) : NULL; - fresult.mem = SWIG_MOVE; + fresult.cmemflags = SWIG_MEM_OWN | SWIG_MEM_RVALUE | SWIG_sp_mem_flags; return fresult; } @@ -2710,7 +2570,7 @@ SWIGEXPORT SwigClassWrapper _wrap_TpetraImport_getSourceMap(SwigClassWrapper con } } fresult.cptr = (new Teuchos::RCP >(static_cast< const Teuchos::RCP >& >(result))); - fresult.mem = SWIG_MOVE; + fresult.cmemflags = SWIG_MEM_OWN | SWIG_MEM_RVALUE | SWIG_constsp_mem_flags; return fresult; } @@ -2747,7 +2607,7 @@ SWIGEXPORT SwigClassWrapper _wrap_TpetraImport_getTargetMap(SwigClassWrapper con } } fresult.cptr = (new Teuchos::RCP >(static_cast< const Teuchos::RCP >& >(result))); - fresult.mem = SWIG_MOVE; + fresult.cmemflags = SWIG_MEM_OWN | SWIG_MEM_RVALUE | SWIG_constsp_mem_flags; return fresult; } @@ -2825,7 +2685,7 @@ SWIGEXPORT SwigClassWrapper _wrap_TpetraImport_setUnion__SWIG_0(SwigClassWrapper } } fresult.cptr = (new Teuchos::RCP >(static_cast< const Teuchos::RCP >& >(result))); - fresult.mem = SWIG_MOVE; + fresult.cmemflags = SWIG_MEM_OWN | SWIG_MEM_RVALUE | SWIG_constsp_mem_flags; return fresult; } @@ -2862,7 +2722,7 @@ SWIGEXPORT SwigClassWrapper _wrap_TpetraImport_setUnion__SWIG_1(SwigClassWrapper } } fresult.cptr = (new Teuchos::RCP >(static_cast< const Teuchos::RCP >& >(result))); - fresult.mem = SWIG_MOVE; + fresult.cmemflags = SWIG_MEM_OWN | SWIG_MEM_RVALUE | SWIG_constsp_mem_flags; return fresult; } @@ -2902,7 +2762,7 @@ SWIGEXPORT SwigClassWrapper _wrap_TpetraImport_createRemoteOnlyImport(SwigClassW } } fresult.cptr = (new Teuchos::RCP >(static_cast< const Teuchos::RCP >& >(result))); - fresult.mem = SWIG_MOVE; + fresult.cmemflags = SWIG_MEM_OWN | SWIG_MEM_RVALUE | SWIG_constsp_mem_flags; return fresult; } @@ -2946,34 +2806,15 @@ SWIGEXPORT void _wrap_TpetraImport_op_assign__(SwigClassWrapper *farg1, SwigClas Tpetra::Import< LO,GO,NO > *arg1 = (Tpetra::Import< LO,GO,NO > *) 0 ; Tpetra::Import< LO,GO,NO > *arg2 = 0 ; Teuchos::RCP< Tpetra::Import< LO,GO,NO > > *smartarg1 ; + Teuchos::RCP< Tpetra::Import< LO,GO,NO > > *smartarg2 ; smartarg1 = static_cast< Teuchos::RCP< Tpetra::Import >* >(farg1->cptr); arg1 = smartarg1 ? const_cast< Tpetra::Import* >(smartarg1->get()) : NULL; - (void)sizeof(arg2); - { - // Make sure no unhandled exceptions exist before performing a new action - SWIG_check_unhandled_exception_impl("Tpetra::Import< LO,GO,NO >::operator =(Tpetra::Import< LO,GO,NO > const &)");; - try - { - // Attempt the wrapped function call - typedef Teuchos::RCP< Tpetra::Import > swig_lhs_classtype; - SWIG_assign(swig_lhs_classtype, farg1, swig_lhs_classtype, farg2, 0 | swig::IS_DESTR | swig::IS_COPY_CONSTR | swig::IS_COPY_ASSIGN); - } - catch (const std::range_error& e) - { - // Store a C++ exception - SWIG_exception_impl("Tpetra::Import< LO,GO,NO >::operator =(Tpetra::Import< LO,GO,NO > const &)", SWIG_IndexError, e.what(), return ); - } - catch (const std::exception& e) - { - // Store a C++ exception - SWIG_exception_impl("Tpetra::Import< LO,GO,NO >::operator =(Tpetra::Import< LO,GO,NO > const &)", SWIG_RuntimeError, e.what(), return ); - } - catch (...) - { - SWIG_exception_impl("Tpetra::Import< LO,GO,NO >::operator =(Tpetra::Import< LO,GO,NO > const &)", SWIG_UnknownError, "An unknown exception occurred", return ); - } - } + SWIG_check_sp_nonnull(farg2, "Tpetra::Import< LO,GO,NO > *", "TpetraImport", "Tpetra::Import< LO,GO,NO >::operator =(Tpetra::Import< LO,GO,NO > &)", return ) + smartarg2 = static_cast< Teuchos::RCP< Tpetra::Import >* >(farg2->cptr); + arg2 = const_cast< Tpetra::Import* >(smartarg2->get()); + SWIG_assign >, SWIGPOLICY_Tpetra__ImportT_int_long_long_Kokkos__Compat__KokkosSerialWrapperNode_t>(farg1, *farg2); + } @@ -3011,7 +2852,7 @@ SWIGEXPORT SwigClassWrapper _wrap_new_TpetraExport__SWIG_0(SwigClassWrapper cons } } fresult.cptr = result ? new Teuchos::RCP< Tpetra::Export >(result SWIG_NO_NULL_DELETER_1) : NULL; - fresult.mem = SWIG_MOVE; + fresult.cmemflags = SWIG_MEM_OWN | SWIG_MEM_RVALUE | SWIG_sp_mem_flags; return fresult; } @@ -3053,7 +2894,7 @@ SWIGEXPORT SwigClassWrapper _wrap_new_TpetraExport__SWIG_1(SwigClassWrapper cons } } fresult.cptr = result ? new Teuchos::RCP< Tpetra::Export >(result SWIG_NO_NULL_DELETER_1) : NULL; - fresult.mem = SWIG_MOVE; + fresult.cmemflags = SWIG_MEM_OWN | SWIG_MEM_RVALUE | SWIG_sp_mem_flags; return fresult; } @@ -3091,7 +2932,7 @@ SWIGEXPORT SwigClassWrapper _wrap_new_TpetraExport__SWIG_2(SwigClassWrapper cons } } fresult.cptr = result ? new Teuchos::RCP< Tpetra::Export >(result SWIG_NO_NULL_DELETER_1) : NULL; - fresult.mem = SWIG_MOVE; + fresult.cmemflags = SWIG_MEM_OWN | SWIG_MEM_RVALUE | SWIG_sp_mem_flags; return fresult; } @@ -3129,7 +2970,7 @@ SWIGEXPORT SwigClassWrapper _wrap_new_TpetraExport__SWIG_3(SwigClassWrapper cons } } fresult.cptr = result ? new Teuchos::RCP< Tpetra::Export >(result SWIG_NO_NULL_DELETER_1) : NULL; - fresult.mem = SWIG_MOVE; + fresult.cmemflags = SWIG_MEM_OWN | SWIG_MEM_RVALUE | SWIG_sp_mem_flags; return fresult; } @@ -3377,7 +3218,7 @@ SWIGEXPORT SwigClassWrapper _wrap_TpetraExport_getSourceMap(SwigClassWrapper con } } fresult.cptr = (new Teuchos::RCP >(static_cast< const Teuchos::RCP >& >(result))); - fresult.mem = SWIG_MOVE; + fresult.cmemflags = SWIG_MEM_OWN | SWIG_MEM_RVALUE | SWIG_constsp_mem_flags; return fresult; } @@ -3414,7 +3255,7 @@ SWIGEXPORT SwigClassWrapper _wrap_TpetraExport_getTargetMap(SwigClassWrapper con } } fresult.cptr = (new Teuchos::RCP >(static_cast< const Teuchos::RCP >& >(result))); - fresult.mem = SWIG_MOVE; + fresult.cmemflags = SWIG_MEM_OWN | SWIG_MEM_RVALUE | SWIG_constsp_mem_flags; return fresult; } @@ -3494,34 +3335,15 @@ SWIGEXPORT void _wrap_TpetraExport_op_assign__(SwigClassWrapper *farg1, SwigClas Tpetra::Export< LO,GO,NO > *arg1 = (Tpetra::Export< LO,GO,NO > *) 0 ; Tpetra::Export< LO,GO,NO > *arg2 = 0 ; Teuchos::RCP< Tpetra::Export< LO,GO,NO > > *smartarg1 ; + Teuchos::RCP< Tpetra::Export< LO,GO,NO > > *smartarg2 ; smartarg1 = static_cast< Teuchos::RCP< Tpetra::Export >* >(farg1->cptr); arg1 = smartarg1 ? const_cast< Tpetra::Export* >(smartarg1->get()) : NULL; - (void)sizeof(arg2); - { - // Make sure no unhandled exceptions exist before performing a new action - SWIG_check_unhandled_exception_impl("Tpetra::Export< LO,GO,NO >::operator =(Tpetra::Export< LO,GO,NO > const &)");; - try - { - // Attempt the wrapped function call - typedef Teuchos::RCP< Tpetra::Export > swig_lhs_classtype; - SWIG_assign(swig_lhs_classtype, farg1, swig_lhs_classtype, farg2, 0 | swig::IS_DESTR | swig::IS_COPY_CONSTR | swig::IS_COPY_ASSIGN); - } - catch (const std::range_error& e) - { - // Store a C++ exception - SWIG_exception_impl("Tpetra::Export< LO,GO,NO >::operator =(Tpetra::Export< LO,GO,NO > const &)", SWIG_IndexError, e.what(), return ); - } - catch (const std::exception& e) - { - // Store a C++ exception - SWIG_exception_impl("Tpetra::Export< LO,GO,NO >::operator =(Tpetra::Export< LO,GO,NO > const &)", SWIG_RuntimeError, e.what(), return ); - } - catch (...) - { - SWIG_exception_impl("Tpetra::Export< LO,GO,NO >::operator =(Tpetra::Export< LO,GO,NO > const &)", SWIG_UnknownError, "An unknown exception occurred", return ); - } - } + SWIG_check_sp_nonnull(farg2, "Tpetra::Export< LO,GO,NO > *", "TpetraExport", "Tpetra::Export< LO,GO,NO >::operator =(Tpetra::Export< LO,GO,NO > &)", return ) + smartarg2 = static_cast< Teuchos::RCP< Tpetra::Export >* >(farg2->cptr); + arg2 = const_cast< Tpetra::Export* >(smartarg2->get()); + SWIG_assign >, SWIGPOLICY_Tpetra__ExportT_int_long_long_Kokkos__Compat__KokkosSerialWrapperNode_t>(farg1, *farg2); + } @@ -3553,7 +3375,7 @@ SWIGEXPORT SwigClassWrapper _wrap_new_TpetraMultiVector__SWIG_0() { } } fresult.cptr = result ? new Teuchos::RCP< Tpetra::MultiVector >(result SWIG_NO_NULL_DELETER_1) : NULL; - fresult.mem = SWIG_MOVE; + fresult.cmemflags = SWIG_MEM_OWN | SWIG_MEM_RVALUE | SWIG_sp_mem_flags; return fresult; } @@ -3593,7 +3415,7 @@ SWIGEXPORT SwigClassWrapper _wrap_new_TpetraMultiVector__SWIG_1(SwigClassWrapper } } fresult.cptr = result ? new Teuchos::RCP< Tpetra::MultiVector >(result SWIG_NO_NULL_DELETER_1) : NULL; - fresult.mem = SWIG_MOVE; + fresult.cmemflags = SWIG_MEM_OWN | SWIG_MEM_RVALUE | SWIG_sp_mem_flags; return fresult; } @@ -3631,7 +3453,7 @@ SWIGEXPORT SwigClassWrapper _wrap_new_TpetraMultiVector__SWIG_2(SwigClassWrapper } } fresult.cptr = result ? new Teuchos::RCP< Tpetra::MultiVector >(result SWIG_NO_NULL_DELETER_1) : NULL; - fresult.mem = SWIG_MOVE; + fresult.cmemflags = SWIG_MEM_OWN | SWIG_MEM_RVALUE | SWIG_sp_mem_flags; return fresult; } @@ -3669,7 +3491,7 @@ SWIGEXPORT SwigClassWrapper _wrap_new_TpetraMultiVector__SWIG_3(SwigClassWrapper } } fresult.cptr = result ? new Teuchos::RCP< Tpetra::MultiVector >(result SWIG_NO_NULL_DELETER_1) : NULL; - fresult.mem = SWIG_MOVE; + fresult.cmemflags = SWIG_MEM_OWN | SWIG_MEM_RVALUE | SWIG_sp_mem_flags; return fresult; } @@ -3709,7 +3531,7 @@ SWIGEXPORT SwigClassWrapper _wrap_new_TpetraMultiVector__SWIG_4(SwigClassWrapper } } fresult.cptr = result ? new Teuchos::RCP< Tpetra::MultiVector >(result SWIG_NO_NULL_DELETER_1) : NULL; - fresult.mem = SWIG_MOVE; + fresult.cmemflags = SWIG_MEM_OWN | SWIG_MEM_RVALUE | SWIG_sp_mem_flags; return fresult; } @@ -3753,7 +3575,7 @@ SWIGEXPORT SwigClassWrapper _wrap_new_TpetraMultiVector__SWIG_5(SwigClassWrapper } } fresult.cptr = result ? new Teuchos::RCP< Tpetra::MultiVector >(result SWIG_NO_NULL_DELETER_1) : NULL; - fresult.mem = SWIG_MOVE; + fresult.cmemflags = SWIG_MEM_OWN | SWIG_MEM_RVALUE | SWIG_sp_mem_flags; return fresult; } @@ -3798,7 +3620,7 @@ SWIGEXPORT SwigClassWrapper _wrap_new_TpetraMultiVector__SWIG_7(SwigClassWrapper } } fresult.cptr = result ? new Teuchos::RCP< Tpetra::MultiVector >(result SWIG_NO_NULL_DELETER_1) : NULL; - fresult.mem = SWIG_MOVE; + fresult.cmemflags = SWIG_MEM_OWN | SWIG_MEM_RVALUE | SWIG_sp_mem_flags; return fresult; } @@ -3841,7 +3663,7 @@ SWIGEXPORT SwigClassWrapper _wrap_new_TpetraMultiVector__SWIG_8(SwigClassWrapper } } fresult.cptr = result ? new Teuchos::RCP< Tpetra::MultiVector >(result SWIG_NO_NULL_DELETER_1) : NULL; - fresult.mem = SWIG_MOVE; + fresult.cmemflags = SWIG_MEM_OWN | SWIG_MEM_RVALUE | SWIG_sp_mem_flags; return fresult; } @@ -4376,7 +4198,7 @@ SWIGEXPORT SwigClassWrapper _wrap_TpetraMultiVector_subCopy(SwigClassWrapper con } } fresult.cptr = (new Teuchos::RCP< Tpetra::MultiVector >(static_cast< const Teuchos::RCP< Tpetra::MultiVector >& >(result))); - fresult.mem = SWIG_MOVE; + fresult.cmemflags = SWIG_MEM_OWN | SWIG_MEM_RVALUE | SWIG_sp_mem_flags; return fresult; } @@ -4423,7 +4245,7 @@ SWIGEXPORT SwigClassWrapper _wrap_TpetraMultiVector_subView(SwigClassWrapper con } } fresult.cptr = (new Teuchos::RCP >(static_cast< const Teuchos::RCP >& >(result))); - fresult.mem = SWIG_MOVE; + fresult.cmemflags = SWIG_MEM_OWN | SWIG_MEM_RVALUE | SWIG_constsp_mem_flags; return fresult; } @@ -4470,7 +4292,7 @@ SWIGEXPORT SwigClassWrapper _wrap_TpetraMultiVector_subViewNonConst(SwigClassWra } } fresult.cptr = (new Teuchos::RCP< Tpetra::MultiVector >(static_cast< const Teuchos::RCP< Tpetra::MultiVector >& >(result))); - fresult.mem = SWIG_MOVE; + fresult.cmemflags = SWIG_MEM_OWN | SWIG_MEM_RVALUE | SWIG_sp_mem_flags; return fresult; } @@ -4512,7 +4334,7 @@ SWIGEXPORT SwigClassWrapper _wrap_TpetraMultiVector_offsetView(SwigClassWrapper } } fresult.cptr = (new Teuchos::RCP >(static_cast< const Teuchos::RCP >& >(result))); - fresult.mem = SWIG_MOVE; + fresult.cmemflags = SWIG_MEM_OWN | SWIG_MEM_RVALUE | SWIG_constsp_mem_flags; return fresult; } @@ -4554,7 +4376,7 @@ SWIGEXPORT SwigClassWrapper _wrap_TpetraMultiVector_offsetViewNonConst(SwigClass } } fresult.cptr = (new Teuchos::RCP< Tpetra::MultiVector >(static_cast< const Teuchos::RCP< Tpetra::MultiVector >& >(result))); - fresult.mem = SWIG_MOVE; + fresult.cmemflags = SWIG_MEM_OWN | SWIG_MEM_RVALUE | SWIG_sp_mem_flags; return fresult; } @@ -6167,34 +5989,15 @@ SWIGEXPORT void _wrap_TpetraMultiVector_op_assign__(SwigClassWrapper *farg1, Swi Tpetra::MultiVector< SC,LO,GO,NO > *arg1 = (Tpetra::MultiVector< SC,LO,GO,NO > *) 0 ; Tpetra::MultiVector< SC,LO,GO,NO > *arg2 = 0 ; Teuchos::RCP< Tpetra::MultiVector< SC,LO,GO,NO > > *smartarg1 ; + Teuchos::RCP< Tpetra::MultiVector< SC,LO,GO,NO > > *smartarg2 ; smartarg1 = static_cast< Teuchos::RCP< Tpetra::MultiVector >* >(farg1->cptr); arg1 = smartarg1 ? const_cast< Tpetra::MultiVector* >(smartarg1->get()) : NULL; - (void)sizeof(arg2); - { - // Make sure no unhandled exceptions exist before performing a new action - SWIG_check_unhandled_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::operator =(Tpetra::MultiVector< SC,LO,GO,NO > const &)");; - try - { - // Attempt the wrapped function call - typedef Teuchos::RCP< Tpetra::MultiVector > swig_lhs_classtype; - SWIG_assign(swig_lhs_classtype, farg1, swig_lhs_classtype, farg2, 0 | swig::IS_DESTR | swig::IS_COPY_CONSTR | swig::IS_COPY_ASSIGN); - } - catch (const std::range_error& e) - { - // Store a C++ exception - SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::operator =(Tpetra::MultiVector< SC,LO,GO,NO > const &)", SWIG_IndexError, e.what(), return ); - } - catch (const std::exception& e) - { - // Store a C++ exception - SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::operator =(Tpetra::MultiVector< SC,LO,GO,NO > const &)", SWIG_RuntimeError, e.what(), return ); - } - catch (...) - { - SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::operator =(Tpetra::MultiVector< SC,LO,GO,NO > const &)", SWIG_UnknownError, "An unknown exception occurred", return ); - } - } + SWIG_check_sp_nonnull(farg2, "Tpetra::MultiVector< SC,LO,GO,NO > *", "TpetraMultiVector", "Tpetra::MultiVector< SC,LO,GO,NO >::operator =(Tpetra::MultiVector< SC,LO,GO,NO > &)", return ) + smartarg2 = static_cast< Teuchos::RCP< Tpetra::MultiVector >* >(farg2->cptr); + arg2 = const_cast< Tpetra::MultiVector* >(smartarg2->get()); + SWIG_assign >, SWIGPOLICY_Tpetra__MultiVectorT_double_int_long_long_Kokkos__Compat__KokkosSerialWrapperNode_t>(farg1, *farg2); + } @@ -6234,34 +6037,15 @@ SWIGEXPORT void _wrap_TpetraOperator_op_assign__(SwigClassWrapper *farg1, SwigCl Tpetra::Operator< SC,LO,GO,NO > *arg1 = (Tpetra::Operator< SC,LO,GO,NO > *) 0 ; Tpetra::Operator< SC,LO,GO,NO > *arg2 = 0 ; Teuchos::RCP< Tpetra::Operator< SC,LO,GO,NO > > *smartarg1 ; + Teuchos::RCP< Tpetra::Operator< SC,LO,GO,NO > > *smartarg2 ; smartarg1 = static_cast< Teuchos::RCP< Tpetra::Operator >* >(farg1->cptr); arg1 = smartarg1 ? const_cast< Tpetra::Operator* >(smartarg1->get()) : NULL; - (void)sizeof(arg2); - { - // Make sure no unhandled exceptions exist before performing a new action - SWIG_check_unhandled_exception_impl("Tpetra::Operator< SC,LO,GO,NO >::operator =(Tpetra::Operator< SC,LO,GO,NO > const &)");; - try - { - // Attempt the wrapped function call - typedef Teuchos::RCP< Tpetra::Operator > swig_lhs_classtype; - SWIG_assign(swig_lhs_classtype, farg1, swig_lhs_classtype, farg2, 0 | swig::IS_DESTR | swig::IS_COPY_CONSTR); - } - catch (const std::range_error& e) - { - // Store a C++ exception - SWIG_exception_impl("Tpetra::Operator< SC,LO,GO,NO >::operator =(Tpetra::Operator< SC,LO,GO,NO > const &)", SWIG_IndexError, e.what(), return ); - } - catch (const std::exception& e) - { - // Store a C++ exception - SWIG_exception_impl("Tpetra::Operator< SC,LO,GO,NO >::operator =(Tpetra::Operator< SC,LO,GO,NO > const &)", SWIG_RuntimeError, e.what(), return ); - } - catch (...) - { - SWIG_exception_impl("Tpetra::Operator< SC,LO,GO,NO >::operator =(Tpetra::Operator< SC,LO,GO,NO > const &)", SWIG_UnknownError, "An unknown exception occurred", return ); - } - } + SWIG_check_sp_nonnull(farg2, "Tpetra::Operator< SC,LO,GO,NO > *", "TpetraOperator", "Tpetra::Operator< SC,LO,GO,NO >::operator =(Tpetra::Operator< SC,LO,GO,NO > &)", return ) + smartarg2 = static_cast< Teuchos::RCP< Tpetra::Operator >* >(farg2->cptr); + arg2 = const_cast< Tpetra::Operator* >(smartarg2->get()); + SWIG_assign >, SWIGPOLICY_Tpetra__OperatorT_double_int_long_long_Kokkos__Compat__KokkosSerialWrapperNode_t>(farg1, *farg2); + } @@ -6363,7 +6147,7 @@ SWIGEXPORT SwigClassWrapper _wrap_new_ForTpetraOperator() { } } fresult.cptr = result ? new Teuchos::RCP< ForTpetraOperator >(result SWIG_NO_NULL_DELETER_1) : NULL; - fresult.mem = SWIG_MOVE; + fresult.cmemflags = SWIG_MEM_OWN | SWIG_MEM_RVALUE | SWIG_sp_mem_flags; return fresult; } @@ -6400,7 +6184,7 @@ SWIGEXPORT SwigClassWrapper _wrap_ForTpetraOperator_getDomainMap(SwigClassWrappe } } fresult.cptr = (new Teuchos::RCP >(static_cast< const Teuchos::RCP >& >(result))); - fresult.mem = SWIG_MOVE; + fresult.cmemflags = SWIG_MEM_OWN | SWIG_MEM_RVALUE | SWIG_constsp_mem_flags; return fresult; } @@ -6437,7 +6221,7 @@ SWIGEXPORT SwigClassWrapper _wrap_ForTpetraOperator_getRangeMap(SwigClassWrapper } } fresult.cptr = (new Teuchos::RCP >(static_cast< const Teuchos::RCP >& >(result))); - fresult.mem = SWIG_MOVE; + fresult.cmemflags = SWIG_MEM_OWN | SWIG_MEM_RVALUE | SWIG_constsp_mem_flags; return fresult; } @@ -6526,37 +6310,15 @@ SWIGEXPORT void _wrap_ForTpetraOperator_op_assign__(SwigClassWrapper *farg1, Swi ForTpetraOperator *arg1 = (ForTpetraOperator *) 0 ; ForTpetraOperator *arg2 = 0 ; Teuchos::RCP< ForTpetraOperator > *smartarg1 ; - Teuchos::RCP< ForTpetraOperator const > *smartarg2 ; + Teuchos::RCP< ForTpetraOperator > *smartarg2 ; smartarg1 = static_cast< Teuchos::RCP< ForTpetraOperator >* >(farg1->cptr); arg1 = smartarg1 ? const_cast< ForTpetraOperator* >(smartarg1->get()) : NULL; - SWIG_check_sp_nonnull(farg2, "ForTpetraOperator *", "ForTpetraOperator", "ForTpetraOperator::operator =(ForTpetraOperator const &)", return ) - smartarg2 = static_cast< Teuchos::RCP* >(farg2->cptr); + SWIG_check_sp_nonnull(farg2, "ForTpetraOperator *", "ForTpetraOperator", "ForTpetraOperator::operator =(ForTpetraOperator &)", return ) + smartarg2 = static_cast< Teuchos::RCP< ForTpetraOperator >* >(farg2->cptr); arg2 = const_cast< ForTpetraOperator* >(smartarg2->get()); - { - // Make sure no unhandled exceptions exist before performing a new action - SWIG_check_unhandled_exception_impl("ForTpetraOperator::operator =(ForTpetraOperator const &)");; - try - { - // Attempt the wrapped function call - typedef Teuchos::RCP< ForTpetraOperator > swig_lhs_classtype; - SWIG_assign(swig_lhs_classtype, farg1, swig_lhs_classtype, farg2, 0 | swig::IS_DESTR | swig::IS_COPY_CONSTR); - } - catch (const std::range_error& e) - { - // Store a C++ exception - SWIG_exception_impl("ForTpetraOperator::operator =(ForTpetraOperator const &)", SWIG_IndexError, e.what(), return ); - } - catch (const std::exception& e) - { - // Store a C++ exception - SWIG_exception_impl("ForTpetraOperator::operator =(ForTpetraOperator const &)", SWIG_RuntimeError, e.what(), return ); - } - catch (...) - { - SWIG_exception_impl("ForTpetraOperator::operator =(ForTpetraOperator const &)", SWIG_UnknownError, "An unknown exception occurred", return ); - } - } + SWIG_assign, SWIGPOLICY_ForTpetraOperator>(farg1, *farg2); + } @@ -6684,7 +6446,7 @@ SWIGEXPORT SwigClassWrapper _wrap_new_RowInfo() { } } fresult.cptr = result; - fresult.mem = (1 ? SWIG_MOVE : SWIG_REF); + fresult.cmemflags = SWIG_MEM_RVALUE | (1 ? SWIG_MEM_OWN : 0); return fresult; } @@ -6692,7 +6454,8 @@ SWIGEXPORT SwigClassWrapper _wrap_new_RowInfo() { SWIGEXPORT void _wrap_delete_RowInfo(SwigClassWrapper *farg1) { Tpetra::RowInfo *arg1 = (Tpetra::RowInfo *) 0 ; - (void)sizeof(farg1); + SWIG_check_mutable(*farg1, "Tpetra::RowInfo *", "RowInfo", "Tpetra::RowInfo::~RowInfo()", return ); + arg1 = static_cast< Tpetra::RowInfo * >(farg1->cptr); { // Make sure no unhandled exceptions exist before performing a new action SWIG_check_unhandled_exception_impl("Tpetra::RowInfo::~RowInfo()");; @@ -6725,30 +6488,8 @@ SWIGEXPORT void _wrap_RowInfo_op_assign__(SwigClassWrapper *farg1, SwigClassWrap (void)sizeof(arg1); (void)sizeof(arg2); - { - // Make sure no unhandled exceptions exist before performing a new action - SWIG_check_unhandled_exception_impl("Tpetra::RowInfo::operator =(Tpetra::RowInfo const &)");; - try - { - // Attempt the wrapped function call - typedef Tpetra::RowInfo swig_lhs_classtype; - SWIG_assign(swig_lhs_classtype, farg1, swig_lhs_classtype, farg2, 0 | swig::IS_DESTR | swig::IS_COPY_CONSTR); - } - catch (const std::range_error& e) - { - // Store a C++ exception - SWIG_exception_impl("Tpetra::RowInfo::operator =(Tpetra::RowInfo const &)", SWIG_IndexError, e.what(), return ); - } - catch (const std::exception& e) - { - // Store a C++ exception - SWIG_exception_impl("Tpetra::RowInfo::operator =(Tpetra::RowInfo const &)", SWIG_RuntimeError, e.what(), return ); - } - catch (...) - { - SWIG_exception_impl("Tpetra::RowInfo::operator =(Tpetra::RowInfo const &)", SWIG_UnknownError, "An unknown exception occurred", return ); - } - } + SWIG_assign(farg1, *farg2); + } @@ -6790,7 +6531,7 @@ SWIGEXPORT SwigClassWrapper _wrap_new_TpetraCrsGraph__SWIG_0(SwigClassWrapper co } } fresult.cptr = result ? new Teuchos::RCP< Tpetra::CrsGraph >(result SWIG_NO_NULL_DELETER_1) : NULL; - fresult.mem = SWIG_MOVE; + fresult.cmemflags = SWIG_MEM_OWN | SWIG_MEM_RVALUE | SWIG_sp_mem_flags; return fresult; } @@ -6830,7 +6571,7 @@ SWIGEXPORT SwigClassWrapper _wrap_new_TpetraCrsGraph__SWIG_1(SwigClassWrapper co } } fresult.cptr = result ? new Teuchos::RCP< Tpetra::CrsGraph >(result SWIG_NO_NULL_DELETER_1) : NULL; - fresult.mem = SWIG_MOVE; + fresult.cmemflags = SWIG_MEM_OWN | SWIG_MEM_RVALUE | SWIG_sp_mem_flags; return fresult; } @@ -6868,7 +6609,7 @@ SWIGEXPORT SwigClassWrapper _wrap_new_TpetraCrsGraph__SWIG_2(SwigClassWrapper co } } fresult.cptr = result ? new Teuchos::RCP< Tpetra::CrsGraph >(result SWIG_NO_NULL_DELETER_1) : NULL; - fresult.mem = SWIG_MOVE; + fresult.cmemflags = SWIG_MEM_OWN | SWIG_MEM_RVALUE | SWIG_sp_mem_flags; return fresult; } @@ -6913,7 +6654,7 @@ SWIGEXPORT SwigClassWrapper _wrap_new_TpetraCrsGraph__SWIG_3(SwigClassWrapper co } } fresult.cptr = result ? new Teuchos::RCP< Tpetra::CrsGraph >(result SWIG_NO_NULL_DELETER_1) : NULL; - fresult.mem = SWIG_MOVE; + fresult.cmemflags = SWIG_MEM_OWN | SWIG_MEM_RVALUE | SWIG_sp_mem_flags; return fresult; } @@ -6955,7 +6696,7 @@ SWIGEXPORT SwigClassWrapper _wrap_new_TpetraCrsGraph__SWIG_4(SwigClassWrapper co } } fresult.cptr = result ? new Teuchos::RCP< Tpetra::CrsGraph >(result SWIG_NO_NULL_DELETER_1) : NULL; - fresult.mem = SWIG_MOVE; + fresult.cmemflags = SWIG_MEM_OWN | SWIG_MEM_RVALUE | SWIG_sp_mem_flags; return fresult; } @@ -6995,7 +6736,7 @@ SWIGEXPORT SwigClassWrapper _wrap_new_TpetraCrsGraph__SWIG_5(SwigClassWrapper co } } fresult.cptr = result ? new Teuchos::RCP< Tpetra::CrsGraph >(result SWIG_NO_NULL_DELETER_1) : NULL; - fresult.mem = SWIG_MOVE; + fresult.cmemflags = SWIG_MEM_OWN | SWIG_MEM_RVALUE | SWIG_sp_mem_flags; return fresult; } @@ -7041,7 +6782,7 @@ SWIGEXPORT SwigClassWrapper _wrap_new_TpetraCrsGraph__SWIG_6(SwigClassWrapper co } } fresult.cptr = result ? new Teuchos::RCP< Tpetra::CrsGraph >(result SWIG_NO_NULL_DELETER_1) : NULL; - fresult.mem = SWIG_MOVE; + fresult.cmemflags = SWIG_MEM_OWN | SWIG_MEM_RVALUE | SWIG_sp_mem_flags; return fresult; } @@ -7084,7 +6825,7 @@ SWIGEXPORT SwigClassWrapper _wrap_new_TpetraCrsGraph__SWIG_7(SwigClassWrapper co } } fresult.cptr = result ? new Teuchos::RCP< Tpetra::CrsGraph >(result SWIG_NO_NULL_DELETER_1) : NULL; - fresult.mem = SWIG_MOVE; + fresult.cmemflags = SWIG_MEM_OWN | SWIG_MEM_RVALUE | SWIG_sp_mem_flags; return fresult; } @@ -7125,7 +6866,7 @@ SWIGEXPORT SwigClassWrapper _wrap_new_TpetraCrsGraph__SWIG_8(SwigClassWrapper co } } fresult.cptr = result ? new Teuchos::RCP< Tpetra::CrsGraph >(result SWIG_NO_NULL_DELETER_1) : NULL; - fresult.mem = SWIG_MOVE; + fresult.cmemflags = SWIG_MEM_OWN | SWIG_MEM_RVALUE | SWIG_sp_mem_flags; return fresult; } @@ -7173,7 +6914,7 @@ SWIGEXPORT SwigClassWrapper _wrap_new_TpetraCrsGraph__SWIG_9(SwigClassWrapper co } } fresult.cptr = result ? new Teuchos::RCP< Tpetra::CrsGraph >(result SWIG_NO_NULL_DELETER_1) : NULL; - fresult.mem = SWIG_MOVE; + fresult.cmemflags = SWIG_MEM_OWN | SWIG_MEM_RVALUE | SWIG_sp_mem_flags; return fresult; } @@ -7218,7 +6959,7 @@ SWIGEXPORT SwigClassWrapper _wrap_new_TpetraCrsGraph__SWIG_10(SwigClassWrapper c } } fresult.cptr = result ? new Teuchos::RCP< Tpetra::CrsGraph >(result SWIG_NO_NULL_DELETER_1) : NULL; - fresult.mem = SWIG_MOVE; + fresult.cmemflags = SWIG_MEM_OWN | SWIG_MEM_RVALUE | SWIG_sp_mem_flags; return fresult; } @@ -7261,7 +7002,7 @@ SWIGEXPORT SwigClassWrapper _wrap_new_TpetraCrsGraph__SWIG_11(SwigClassWrapper c } } fresult.cptr = result ? new Teuchos::RCP< Tpetra::CrsGraph >(result SWIG_NO_NULL_DELETER_1) : NULL; - fresult.mem = SWIG_MOVE; + fresult.cmemflags = SWIG_MEM_OWN | SWIG_MEM_RVALUE | SWIG_sp_mem_flags; return fresult; } @@ -7323,7 +7064,7 @@ SWIGEXPORT SwigClassWrapper _wrap_new_TpetraCrsGraph__SWIG_12(SwigClassWrapper c } } fresult.cptr = result ? new Teuchos::RCP< Tpetra::CrsGraph >(result SWIG_NO_NULL_DELETER_1) : NULL; - fresult.mem = SWIG_MOVE; + fresult.cmemflags = SWIG_MEM_OWN | SWIG_MEM_RVALUE | SWIG_sp_mem_flags; return fresult; } @@ -7382,7 +7123,7 @@ SWIGEXPORT SwigClassWrapper _wrap_new_TpetraCrsGraph__SWIG_13(SwigClassWrapper c } } fresult.cptr = result ? new Teuchos::RCP< Tpetra::CrsGraph >(result SWIG_NO_NULL_DELETER_1) : NULL; - fresult.mem = SWIG_MOVE; + fresult.cmemflags = SWIG_MEM_OWN | SWIG_MEM_RVALUE | SWIG_sp_mem_flags; return fresult; } @@ -7564,7 +7305,7 @@ SWIGEXPORT SwigClassWrapper _wrap_TpetraCrsGraph_getValidParameters(SwigClassWra } } fresult.cptr = (new Teuchos::RCP(static_cast< const Teuchos::RCP& >(result))); - fresult.mem = SWIG_MOVE; + fresult.cmemflags = SWIG_MEM_OWN | SWIG_MEM_RVALUE | SWIG_constsp_mem_flags; return fresult; } @@ -8170,7 +7911,7 @@ SWIGEXPORT SwigClassWrapper _wrap_TpetraCrsGraph_getComm(SwigClassWrapper const } } fresult.cptr = (new Teuchos::RCP >(static_cast< const Teuchos::RCP >& >(result))); - fresult.mem = SWIG_MOVE; + fresult.cmemflags = SWIG_MEM_OWN | SWIG_MEM_RVALUE | SWIG_constsp_mem_flags; return fresult; } @@ -8207,7 +7948,7 @@ SWIGEXPORT SwigClassWrapper _wrap_TpetraCrsGraph_getRowMap(SwigClassWrapper cons } } fresult.cptr = (new Teuchos::RCP >(static_cast< const Teuchos::RCP >& >(result))); - fresult.mem = SWIG_MOVE; + fresult.cmemflags = SWIG_MEM_OWN | SWIG_MEM_RVALUE | SWIG_constsp_mem_flags; return fresult; } @@ -8244,7 +7985,7 @@ SWIGEXPORT SwigClassWrapper _wrap_TpetraCrsGraph_getColMap(SwigClassWrapper cons } } fresult.cptr = (new Teuchos::RCP >(static_cast< const Teuchos::RCP >& >(result))); - fresult.mem = SWIG_MOVE; + fresult.cmemflags = SWIG_MEM_OWN | SWIG_MEM_RVALUE | SWIG_constsp_mem_flags; return fresult; } @@ -8281,7 +8022,7 @@ SWIGEXPORT SwigClassWrapper _wrap_TpetraCrsGraph_getDomainMap(SwigClassWrapper c } } fresult.cptr = (new Teuchos::RCP >(static_cast< const Teuchos::RCP >& >(result))); - fresult.mem = SWIG_MOVE; + fresult.cmemflags = SWIG_MEM_OWN | SWIG_MEM_RVALUE | SWIG_constsp_mem_flags; return fresult; } @@ -8318,7 +8059,7 @@ SWIGEXPORT SwigClassWrapper _wrap_TpetraCrsGraph_getRangeMap(SwigClassWrapper co } } fresult.cptr = (new Teuchos::RCP >(static_cast< const Teuchos::RCP >& >(result))); - fresult.mem = SWIG_MOVE; + fresult.cmemflags = SWIG_MEM_OWN | SWIG_MEM_RVALUE | SWIG_constsp_mem_flags; return fresult; } @@ -8355,7 +8096,7 @@ SWIGEXPORT SwigClassWrapper _wrap_TpetraCrsGraph_getImporter(SwigClassWrapper co } } fresult.cptr = (new Teuchos::RCP >(static_cast< const Teuchos::RCP >& >(result))); - fresult.mem = SWIG_MOVE; + fresult.cmemflags = SWIG_MEM_OWN | SWIG_MEM_RVALUE | SWIG_constsp_mem_flags; return fresult; } @@ -8392,7 +8133,7 @@ SWIGEXPORT SwigClassWrapper _wrap_TpetraCrsGraph_getExporter(SwigClassWrapper co } } fresult.cptr = (new Teuchos::RCP >(static_cast< const Teuchos::RCP >& >(result))); - fresult.mem = SWIG_MOVE; + fresult.cmemflags = SWIG_MEM_OWN | SWIG_MEM_RVALUE | SWIG_constsp_mem_flags; return fresult; } @@ -10241,34 +9982,15 @@ SWIGEXPORT void _wrap_TpetraCrsGraph_op_assign__(SwigClassWrapper *farg1, SwigCl Tpetra::CrsGraph< LO,GO,NO > *arg1 = (Tpetra::CrsGraph< LO,GO,NO > *) 0 ; Tpetra::CrsGraph< LO,GO,NO > *arg2 = 0 ; Teuchos::RCP< Tpetra::CrsGraph< LO,GO,NO > > *smartarg1 ; + Teuchos::RCP< Tpetra::CrsGraph< LO,GO,NO > > *smartarg2 ; smartarg1 = static_cast< Teuchos::RCP< Tpetra::CrsGraph >* >(farg1->cptr); arg1 = smartarg1 ? const_cast< Tpetra::CrsGraph* >(smartarg1->get()) : NULL; - (void)sizeof(arg2); - { - // Make sure no unhandled exceptions exist before performing a new action - SWIG_check_unhandled_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::operator =(Tpetra::CrsGraph< LO,GO,NO > const &)");; - try - { - // Attempt the wrapped function call - typedef Teuchos::RCP< Tpetra::CrsGraph > swig_lhs_classtype; - SWIG_assign(swig_lhs_classtype, farg1, swig_lhs_classtype, farg2, 0 | swig::IS_DESTR | swig::IS_COPY_CONSTR); - } - catch (const std::range_error& e) - { - // Store a C++ exception - SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::operator =(Tpetra::CrsGraph< LO,GO,NO > const &)", SWIG_IndexError, e.what(), return ); - } - catch (const std::exception& e) - { - // Store a C++ exception - SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::operator =(Tpetra::CrsGraph< LO,GO,NO > const &)", SWIG_RuntimeError, e.what(), return ); - } - catch (...) - { - SWIG_exception_impl("Tpetra::CrsGraph< LO,GO,NO >::operator =(Tpetra::CrsGraph< LO,GO,NO > const &)", SWIG_UnknownError, "An unknown exception occurred", return ); - } - } + SWIG_check_sp_nonnull(farg2, "Tpetra::CrsGraph< LO,GO,NO > *", "TpetraCrsGraph", "Tpetra::CrsGraph< LO,GO,NO >::operator =(Tpetra::CrsGraph< LO,GO,NO > &)", return ) + smartarg2 = static_cast< Teuchos::RCP< Tpetra::CrsGraph >* >(farg2->cptr); + arg2 = const_cast< Tpetra::CrsGraph* >(smartarg2->get()); + SWIG_assign >, SWIGPOLICY_Tpetra__CrsGraphT_int_long_long_Kokkos__Compat__KokkosSerialWrapperNode_t>(farg1, *farg2); + } @@ -10310,7 +10032,7 @@ SWIGEXPORT SwigClassWrapper _wrap_new_TpetraCrsMatrix__SWIG_0(SwigClassWrapper c } } fresult.cptr = result ? new Teuchos::RCP< Tpetra::CrsMatrix >(result SWIG_NO_NULL_DELETER_1) : NULL; - fresult.mem = SWIG_MOVE; + fresult.cmemflags = SWIG_MEM_OWN | SWIG_MEM_RVALUE | SWIG_sp_mem_flags; return fresult; } @@ -10350,7 +10072,7 @@ SWIGEXPORT SwigClassWrapper _wrap_new_TpetraCrsMatrix__SWIG_1(SwigClassWrapper c } } fresult.cptr = result ? new Teuchos::RCP< Tpetra::CrsMatrix >(result SWIG_NO_NULL_DELETER_1) : NULL; - fresult.mem = SWIG_MOVE; + fresult.cmemflags = SWIG_MEM_OWN | SWIG_MEM_RVALUE | SWIG_sp_mem_flags; return fresult; } @@ -10388,7 +10110,7 @@ SWIGEXPORT SwigClassWrapper _wrap_new_TpetraCrsMatrix__SWIG_2(SwigClassWrapper c } } fresult.cptr = result ? new Teuchos::RCP< Tpetra::CrsMatrix >(result SWIG_NO_NULL_DELETER_1) : NULL; - fresult.mem = SWIG_MOVE; + fresult.cmemflags = SWIG_MEM_OWN | SWIG_MEM_RVALUE | SWIG_sp_mem_flags; return fresult; } @@ -10433,7 +10155,7 @@ SWIGEXPORT SwigClassWrapper _wrap_new_TpetraCrsMatrix__SWIG_3(SwigClassWrapper c } } fresult.cptr = result ? new Teuchos::RCP< Tpetra::CrsMatrix >(result SWIG_NO_NULL_DELETER_1) : NULL; - fresult.mem = SWIG_MOVE; + fresult.cmemflags = SWIG_MEM_OWN | SWIG_MEM_RVALUE | SWIG_sp_mem_flags; return fresult; } @@ -10475,7 +10197,7 @@ SWIGEXPORT SwigClassWrapper _wrap_new_TpetraCrsMatrix__SWIG_4(SwigClassWrapper c } } fresult.cptr = result ? new Teuchos::RCP< Tpetra::CrsMatrix >(result SWIG_NO_NULL_DELETER_1) : NULL; - fresult.mem = SWIG_MOVE; + fresult.cmemflags = SWIG_MEM_OWN | SWIG_MEM_RVALUE | SWIG_sp_mem_flags; return fresult; } @@ -10515,7 +10237,7 @@ SWIGEXPORT SwigClassWrapper _wrap_new_TpetraCrsMatrix__SWIG_5(SwigClassWrapper c } } fresult.cptr = result ? new Teuchos::RCP< Tpetra::CrsMatrix >(result SWIG_NO_NULL_DELETER_1) : NULL; - fresult.mem = SWIG_MOVE; + fresult.cmemflags = SWIG_MEM_OWN | SWIG_MEM_RVALUE | SWIG_sp_mem_flags; return fresult; } @@ -10561,7 +10283,7 @@ SWIGEXPORT SwigClassWrapper _wrap_new_TpetraCrsMatrix__SWIG_6(SwigClassWrapper c } } fresult.cptr = result ? new Teuchos::RCP< Tpetra::CrsMatrix >(result SWIG_NO_NULL_DELETER_1) : NULL; - fresult.mem = SWIG_MOVE; + fresult.cmemflags = SWIG_MEM_OWN | SWIG_MEM_RVALUE | SWIG_sp_mem_flags; return fresult; } @@ -10604,7 +10326,7 @@ SWIGEXPORT SwigClassWrapper _wrap_new_TpetraCrsMatrix__SWIG_7(SwigClassWrapper c } } fresult.cptr = result ? new Teuchos::RCP< Tpetra::CrsMatrix >(result SWIG_NO_NULL_DELETER_1) : NULL; - fresult.mem = SWIG_MOVE; + fresult.cmemflags = SWIG_MEM_OWN | SWIG_MEM_RVALUE | SWIG_sp_mem_flags; return fresult; } @@ -10645,7 +10367,7 @@ SWIGEXPORT SwigClassWrapper _wrap_new_TpetraCrsMatrix__SWIG_8(SwigClassWrapper c } } fresult.cptr = result ? new Teuchos::RCP< Tpetra::CrsMatrix >(result SWIG_NO_NULL_DELETER_1) : NULL; - fresult.mem = SWIG_MOVE; + fresult.cmemflags = SWIG_MEM_OWN | SWIG_MEM_RVALUE | SWIG_sp_mem_flags; return fresult; } @@ -10693,7 +10415,7 @@ SWIGEXPORT SwigClassWrapper _wrap_new_TpetraCrsMatrix__SWIG_9(SwigClassWrapper c } } fresult.cptr = result ? new Teuchos::RCP< Tpetra::CrsMatrix >(result SWIG_NO_NULL_DELETER_1) : NULL; - fresult.mem = SWIG_MOVE; + fresult.cmemflags = SWIG_MEM_OWN | SWIG_MEM_RVALUE | SWIG_sp_mem_flags; return fresult; } @@ -10738,7 +10460,7 @@ SWIGEXPORT SwigClassWrapper _wrap_new_TpetraCrsMatrix__SWIG_10(SwigClassWrapper } } fresult.cptr = result ? new Teuchos::RCP< Tpetra::CrsMatrix >(result SWIG_NO_NULL_DELETER_1) : NULL; - fresult.mem = SWIG_MOVE; + fresult.cmemflags = SWIG_MEM_OWN | SWIG_MEM_RVALUE | SWIG_sp_mem_flags; return fresult; } @@ -10781,7 +10503,7 @@ SWIGEXPORT SwigClassWrapper _wrap_new_TpetraCrsMatrix__SWIG_11(SwigClassWrapper } } fresult.cptr = result ? new Teuchos::RCP< Tpetra::CrsMatrix >(result SWIG_NO_NULL_DELETER_1) : NULL; - fresult.mem = SWIG_MOVE; + fresult.cmemflags = SWIG_MEM_OWN | SWIG_MEM_RVALUE | SWIG_sp_mem_flags; return fresult; } @@ -10820,7 +10542,7 @@ SWIGEXPORT SwigClassWrapper _wrap_new_TpetraCrsMatrix__SWIG_12(SwigClassWrapper } } fresult.cptr = result ? new Teuchos::RCP< Tpetra::CrsMatrix >(result SWIG_NO_NULL_DELETER_1) : NULL; - fresult.mem = SWIG_MOVE; + fresult.cmemflags = SWIG_MEM_OWN | SWIG_MEM_RVALUE | SWIG_sp_mem_flags; return fresult; } @@ -10856,7 +10578,7 @@ SWIGEXPORT SwigClassWrapper _wrap_new_TpetraCrsMatrix__SWIG_13(SwigClassWrapper } } fresult.cptr = result ? new Teuchos::RCP< Tpetra::CrsMatrix >(result SWIG_NO_NULL_DELETER_1) : NULL; - fresult.mem = SWIG_MOVE; + fresult.cmemflags = SWIG_MEM_OWN | SWIG_MEM_RVALUE | SWIG_sp_mem_flags; return fresult; } @@ -10898,7 +10620,7 @@ SWIGEXPORT SwigClassWrapper _wrap_new_TpetraCrsMatrix__SWIG_14(SwigClassWrapper } } fresult.cptr = result ? new Teuchos::RCP< Tpetra::CrsMatrix >(result SWIG_NO_NULL_DELETER_1) : NULL; - fresult.mem = SWIG_MOVE; + fresult.cmemflags = SWIG_MEM_OWN | SWIG_MEM_RVALUE | SWIG_sp_mem_flags; return fresult; } @@ -10937,7 +10659,7 @@ SWIGEXPORT SwigClassWrapper _wrap_new_TpetraCrsMatrix__SWIG_15(SwigClassWrapper } } fresult.cptr = result ? new Teuchos::RCP< Tpetra::CrsMatrix >(result SWIG_NO_NULL_DELETER_1) : NULL; - fresult.mem = SWIG_MOVE; + fresult.cmemflags = SWIG_MEM_OWN | SWIG_MEM_RVALUE | SWIG_sp_mem_flags; return fresult; } @@ -11003,7 +10725,7 @@ SWIGEXPORT SwigClassWrapper _wrap_new_TpetraCrsMatrix__SWIG_16(SwigClassWrapper } } fresult.cptr = result ? new Teuchos::RCP< Tpetra::CrsMatrix >(result SWIG_NO_NULL_DELETER_1) : NULL; - fresult.mem = SWIG_MOVE; + fresult.cmemflags = SWIG_MEM_OWN | SWIG_MEM_RVALUE | SWIG_sp_mem_flags; return fresult; } @@ -11066,7 +10788,7 @@ SWIGEXPORT SwigClassWrapper _wrap_new_TpetraCrsMatrix__SWIG_17(SwigClassWrapper } } fresult.cptr = result ? new Teuchos::RCP< Tpetra::CrsMatrix >(result SWIG_NO_NULL_DELETER_1) : NULL; - fresult.mem = SWIG_MOVE; + fresult.cmemflags = SWIG_MEM_OWN | SWIG_MEM_RVALUE | SWIG_sp_mem_flags; return fresult; } @@ -12249,7 +11971,7 @@ SWIGEXPORT SwigClassWrapper _wrap_TpetraCrsMatrix_getComm(SwigClassWrapper const } } fresult.cptr = (new Teuchos::RCP >(static_cast< const Teuchos::RCP >& >(result))); - fresult.mem = SWIG_MOVE; + fresult.cmemflags = SWIG_MEM_OWN | SWIG_MEM_RVALUE | SWIG_constsp_mem_flags; return fresult; } @@ -12286,7 +12008,7 @@ SWIGEXPORT SwigClassWrapper _wrap_TpetraCrsMatrix_getRowMap(SwigClassWrapper con } } fresult.cptr = (new Teuchos::RCP >(static_cast< const Teuchos::RCP >& >(result))); - fresult.mem = SWIG_MOVE; + fresult.cmemflags = SWIG_MEM_OWN | SWIG_MEM_RVALUE | SWIG_constsp_mem_flags; return fresult; } @@ -12323,7 +12045,7 @@ SWIGEXPORT SwigClassWrapper _wrap_TpetraCrsMatrix_getColMap(SwigClassWrapper con } } fresult.cptr = (new Teuchos::RCP >(static_cast< const Teuchos::RCP >& >(result))); - fresult.mem = SWIG_MOVE; + fresult.cmemflags = SWIG_MEM_OWN | SWIG_MEM_RVALUE | SWIG_constsp_mem_flags; return fresult; } @@ -12360,7 +12082,7 @@ SWIGEXPORT SwigClassWrapper _wrap_TpetraCrsMatrix_getCrsGraph(SwigClassWrapper c } } fresult.cptr = (new Teuchos::RCP >(static_cast< const Teuchos::RCP >& >(result))); - fresult.mem = SWIG_MOVE; + fresult.cmemflags = SWIG_MEM_OWN | SWIG_MEM_RVALUE | SWIG_constsp_mem_flags; return fresult; } @@ -13508,7 +13230,7 @@ SWIGEXPORT SwigClassWrapper _wrap_TpetraCrsMatrix_getDomainMap(SwigClassWrapper } } fresult.cptr = (new Teuchos::RCP >(static_cast< const Teuchos::RCP >& >(result))); - fresult.mem = SWIG_MOVE; + fresult.cmemflags = SWIG_MEM_OWN | SWIG_MEM_RVALUE | SWIG_constsp_mem_flags; return fresult; } @@ -13545,7 +13267,7 @@ SWIGEXPORT SwigClassWrapper _wrap_TpetraCrsMatrix_getRangeMap(SwigClassWrapper c } } fresult.cptr = (new Teuchos::RCP >(static_cast< const Teuchos::RCP >& >(result))); - fresult.mem = SWIG_MOVE; + fresult.cmemflags = SWIG_MEM_OWN | SWIG_MEM_RVALUE | SWIG_constsp_mem_flags; return fresult; } @@ -14195,34 +13917,15 @@ SWIGEXPORT void _wrap_TpetraCrsMatrix_op_assign__(SwigClassWrapper *farg1, SwigC Tpetra::CrsMatrix< SC,LO,GO,NO > *arg1 = (Tpetra::CrsMatrix< SC,LO,GO,NO > *) 0 ; Tpetra::CrsMatrix< SC,LO,GO,NO > *arg2 = 0 ; Teuchos::RCP< Tpetra::CrsMatrix< SC,LO,GO,NO > > *smartarg1 ; + Teuchos::RCP< Tpetra::CrsMatrix< SC,LO,GO,NO > > *smartarg2 ; smartarg1 = static_cast< Teuchos::RCP< Tpetra::CrsMatrix >* >(farg1->cptr); arg1 = smartarg1 ? const_cast< Tpetra::CrsMatrix* >(smartarg1->get()) : NULL; - (void)sizeof(arg2); - { - // Make sure no unhandled exceptions exist before performing a new action - SWIG_check_unhandled_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::operator =(Tpetra::CrsMatrix< SC,LO,GO,NO > const &)");; - try - { - // Attempt the wrapped function call - typedef Teuchos::RCP< Tpetra::CrsMatrix > swig_lhs_classtype; - SWIG_assign(swig_lhs_classtype, farg1, swig_lhs_classtype, farg2, 0 | swig::IS_DESTR); - } - catch (const std::range_error& e) - { - // Store a C++ exception - SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::operator =(Tpetra::CrsMatrix< SC,LO,GO,NO > const &)", SWIG_IndexError, e.what(), return ); - } - catch (const std::exception& e) - { - // Store a C++ exception - SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::operator =(Tpetra::CrsMatrix< SC,LO,GO,NO > const &)", SWIG_RuntimeError, e.what(), return ); - } - catch (...) - { - SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::operator =(Tpetra::CrsMatrix< SC,LO,GO,NO > const &)", SWIG_UnknownError, "An unknown exception occurred", return ); - } - } + SWIG_check_sp_nonnull(farg2, "Tpetra::CrsMatrix< SC,LO,GO,NO > *", "TpetraCrsMatrix", "Tpetra::CrsMatrix< SC,LO,GO,NO >::operator =(Tpetra::CrsMatrix< SC,LO,GO,NO > &)", return ) + smartarg2 = static_cast< Teuchos::RCP< Tpetra::CrsMatrix >* >(farg2->cptr); + arg2 = const_cast< Tpetra::CrsMatrix* >(smartarg2->get()); + SWIG_assign >, SWIGPOLICY_Tpetra__CrsMatrixT_double_int_long_long_Kokkos__Compat__KokkosSerialWrapperNode_t>(farg1, *farg2); + } @@ -14256,7 +13959,7 @@ SWIGEXPORT SwigClassWrapper _wrap_operator_to_matrix(SwigClassWrapper const *far } } fresult.cptr = (new Teuchos::RCP< Tpetra::CrsMatrix >(static_cast< const Teuchos::RCP< Tpetra::CrsMatrix >& >(result))); - fresult.mem = SWIG_MOVE; + fresult.cmemflags = SWIG_MEM_OWN | SWIG_MEM_RVALUE | SWIG_sp_mem_flags; return fresult; } @@ -14291,7 +13994,7 @@ SWIGEXPORT SwigClassWrapper _wrap_matrix_to_operator(SwigClassWrapper const *far } } fresult.cptr = (new Teuchos::RCP< Tpetra::Operator >(static_cast< const Teuchos::RCP< Tpetra::Operator >& >(result))); - fresult.mem = SWIG_MOVE; + fresult.cmemflags = SWIG_MEM_OWN | SWIG_MEM_RVALUE | SWIG_sp_mem_flags; return fresult; } @@ -14333,7 +14036,7 @@ SWIGEXPORT SwigClassWrapper _wrap_TpetraReader_readSparseGraphFile__SWIG_0(SwigA } } fresult.cptr = (new Teuchos::RCP< Tpetra::CrsGraph >(static_cast< const Teuchos::RCP< Tpetra::CrsGraph >& >(result))); - fresult.mem = SWIG_MOVE; + fresult.cmemflags = SWIG_MEM_OWN | SWIG_MEM_RVALUE | SWIG_sp_mem_flags; return fresult; } @@ -14373,7 +14076,7 @@ SWIGEXPORT SwigClassWrapper _wrap_TpetraReader_readSparseGraphFile__SWIG_1(SwigA } } fresult.cptr = (new Teuchos::RCP< Tpetra::CrsGraph >(static_cast< const Teuchos::RCP< Tpetra::CrsGraph >& >(result))); - fresult.mem = SWIG_MOVE; + fresult.cmemflags = SWIG_MEM_OWN | SWIG_MEM_RVALUE | SWIG_sp_mem_flags; return fresult; } @@ -14419,7 +14122,7 @@ SWIGEXPORT SwigClassWrapper _wrap_TpetraReader_readSparseGraphFile__SWIG_2(SwigA } } fresult.cptr = (new Teuchos::RCP< Tpetra::CrsGraph >(static_cast< const Teuchos::RCP< Tpetra::CrsGraph >& >(result))); - fresult.mem = SWIG_MOVE; + fresult.cmemflags = SWIG_MEM_OWN | SWIG_MEM_RVALUE | SWIG_sp_mem_flags; return fresult; } @@ -14470,7 +14173,7 @@ SWIGEXPORT SwigClassWrapper _wrap_TpetraReader_readSparseGraphFile__SWIG_3(SwigA } } fresult.cptr = (new Teuchos::RCP< Tpetra::CrsGraph >(static_cast< const Teuchos::RCP< Tpetra::CrsGraph >& >(result))); - fresult.mem = SWIG_MOVE; + fresult.cmemflags = SWIG_MEM_OWN | SWIG_MEM_RVALUE | SWIG_sp_mem_flags; return fresult; } @@ -14519,7 +14222,7 @@ SWIGEXPORT SwigClassWrapper _wrap_TpetraReader_readSparseGraphFile__SWIG_4(SwigA } } fresult.cptr = (new Teuchos::RCP< Tpetra::CrsGraph >(static_cast< const Teuchos::RCP< Tpetra::CrsGraph >& >(result))); - fresult.mem = SWIG_MOVE; + fresult.cmemflags = SWIG_MEM_OWN | SWIG_MEM_RVALUE | SWIG_sp_mem_flags; return fresult; } @@ -14561,7 +14264,7 @@ SWIGEXPORT SwigClassWrapper _wrap_TpetraReader_readSparseFile__SWIG_0(SwigArrayW } } fresult.cptr = (new Teuchos::RCP< Tpetra::CrsMatrix >(static_cast< const Teuchos::RCP< Tpetra::CrsMatrix >& >(result))); - fresult.mem = SWIG_MOVE; + fresult.cmemflags = SWIG_MEM_OWN | SWIG_MEM_RVALUE | SWIG_sp_mem_flags; return fresult; } @@ -14601,7 +14304,7 @@ SWIGEXPORT SwigClassWrapper _wrap_TpetraReader_readSparseFile__SWIG_1(SwigArrayW } } fresult.cptr = (new Teuchos::RCP< Tpetra::CrsMatrix >(static_cast< const Teuchos::RCP< Tpetra::CrsMatrix >& >(result))); - fresult.mem = SWIG_MOVE; + fresult.cmemflags = SWIG_MEM_OWN | SWIG_MEM_RVALUE | SWIG_sp_mem_flags; return fresult; } @@ -14647,7 +14350,7 @@ SWIGEXPORT SwigClassWrapper _wrap_TpetraReader_readSparseFile__SWIG_2(SwigArrayW } } fresult.cptr = (new Teuchos::RCP< Tpetra::CrsMatrix >(static_cast< const Teuchos::RCP< Tpetra::CrsMatrix >& >(result))); - fresult.mem = SWIG_MOVE; + fresult.cmemflags = SWIG_MEM_OWN | SWIG_MEM_RVALUE | SWIG_sp_mem_flags; return fresult; } @@ -14698,7 +14401,7 @@ SWIGEXPORT SwigClassWrapper _wrap_TpetraReader_readSparseFile__SWIG_3(SwigArrayW } } fresult.cptr = (new Teuchos::RCP< Tpetra::CrsMatrix >(static_cast< const Teuchos::RCP< Tpetra::CrsMatrix >& >(result))); - fresult.mem = SWIG_MOVE; + fresult.cmemflags = SWIG_MEM_OWN | SWIG_MEM_RVALUE | SWIG_sp_mem_flags; return fresult; } @@ -14747,7 +14450,7 @@ SWIGEXPORT SwigClassWrapper _wrap_TpetraReader_readSparseFile__SWIG_4(SwigArrayW } } fresult.cptr = (new Teuchos::RCP< Tpetra::CrsMatrix >(static_cast< const Teuchos::RCP< Tpetra::CrsMatrix >& >(result))); - fresult.mem = SWIG_MOVE; + fresult.cmemflags = SWIG_MEM_OWN | SWIG_MEM_RVALUE | SWIG_sp_mem_flags; return fresult; } @@ -14790,7 +14493,7 @@ SWIGEXPORT SwigClassWrapper _wrap_TpetraReader_readDenseFile(SwigArrayWrapper *f } } fresult.cptr = (new Teuchos::RCP< Tpetra::MultiVector >(static_cast< const Teuchos::RCP< Tpetra::MultiVector >& >(result))); - fresult.mem = SWIG_MOVE; + fresult.cmemflags = SWIG_MEM_OWN | SWIG_MEM_RVALUE | SWIG_sp_mem_flags; return fresult; } @@ -14830,7 +14533,7 @@ SWIGEXPORT SwigClassWrapper _wrap_TpetraReader_readMapFile(SwigArrayWrapper *far } } fresult.cptr = (new Teuchos::RCP >(static_cast< const Teuchos::RCP >& >(result))); - fresult.mem = SWIG_MOVE; + fresult.cmemflags = SWIG_MEM_OWN | SWIG_MEM_RVALUE | SWIG_constsp_mem_flags; return fresult; } @@ -14871,34 +14574,15 @@ SWIGEXPORT void _wrap_TpetraReader_op_assign__(SwigClassWrapper *farg1, SwigClas Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > > *arg1 = (Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > > *) 0 ; Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > > *arg2 = 0 ; Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > > > *smartarg1 ; + Teuchos::RCP< Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > > > *smartarg2 ; smartarg1 = static_cast< Teuchos::RCP< Tpetra::MatrixMarket::Reader > >* >(farg1->cptr); arg1 = smartarg1 ? const_cast< Tpetra::MatrixMarket::Reader >* >(smartarg1->get()) : NULL; - (void)sizeof(arg2); - { - // Make sure no unhandled exceptions exist before performing a new action - SWIG_check_unhandled_exception_impl("Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::operator =(Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > > const &)");; - try - { - // Attempt the wrapped function call - typedef Teuchos::RCP< Tpetra::MatrixMarket::Reader > > swig_lhs_classtype; - SWIG_assign(swig_lhs_classtype, farg1, swig_lhs_classtype, farg2, 0 | swig::IS_DESTR | swig::IS_COPY_CONSTR); - } - catch (const std::range_error& e) - { - // Store a C++ exception - SWIG_exception_impl("Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::operator =(Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > > const &)", SWIG_IndexError, e.what(), return ); - } - catch (const std::exception& e) - { - // Store a C++ exception - SWIG_exception_impl("Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::operator =(Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > > const &)", SWIG_RuntimeError, e.what(), return ); - } - catch (...) - { - SWIG_exception_impl("Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::operator =(Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > > const &)", SWIG_UnknownError, "An unknown exception occurred", return ); - } - } + SWIG_check_sp_nonnull(farg2, "Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > > *", "TpetraReader", "Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > >::operator =(Tpetra::MatrixMarket::Reader< Tpetra::CrsMatrix< SC,LO,GO,NO > > &)", return ) + smartarg2 = static_cast< Teuchos::RCP< Tpetra::MatrixMarket::Reader > >* >(farg2->cptr); + arg2 = const_cast< Tpetra::MatrixMarket::Reader >* >(smartarg2->get()); + SWIG_assign > >, SWIGPOLICY_Tpetra__MatrixMarket__ReaderT_Tpetra__CrsMatrixT_SC_LO_GO_NO_t_t>(farg1, *farg2); + } @@ -15172,34 +14856,15 @@ SWIGEXPORT void _wrap_TpetraWriter_op_assign__(SwigClassWrapper *farg1, SwigClas Tpetra::MatrixMarket::Writer< Tpetra::CrsMatrix< SC,LO,GO,NO > > *arg1 = (Tpetra::MatrixMarket::Writer< Tpetra::CrsMatrix< SC,LO,GO,NO > > *) 0 ; Tpetra::MatrixMarket::Writer< Tpetra::CrsMatrix< SC,LO,GO,NO > > *arg2 = 0 ; Teuchos::RCP< Tpetra::MatrixMarket::Writer< Tpetra::CrsMatrix< SC,LO,GO,NO > > > *smartarg1 ; + Teuchos::RCP< Tpetra::MatrixMarket::Writer< Tpetra::CrsMatrix< SC,LO,GO,NO > > > *smartarg2 ; smartarg1 = static_cast< Teuchos::RCP< Tpetra::MatrixMarket::Writer > >* >(farg1->cptr); arg1 = smartarg1 ? const_cast< Tpetra::MatrixMarket::Writer >* >(smartarg1->get()) : NULL; - (void)sizeof(arg2); - { - // Make sure no unhandled exceptions exist before performing a new action - SWIG_check_unhandled_exception_impl("Tpetra::MatrixMarket::Writer< Tpetra::CrsMatrix< SC,LO,GO,NO > >::operator =(Tpetra::MatrixMarket::Writer< Tpetra::CrsMatrix< SC,LO,GO,NO > > const &)");; - try - { - // Attempt the wrapped function call - typedef Teuchos::RCP< Tpetra::MatrixMarket::Writer > > swig_lhs_classtype; - SWIG_assign(swig_lhs_classtype, farg1, swig_lhs_classtype, farg2, 0 | swig::IS_DESTR | swig::IS_COPY_CONSTR); - } - catch (const std::range_error& e) - { - // Store a C++ exception - SWIG_exception_impl("Tpetra::MatrixMarket::Writer< Tpetra::CrsMatrix< SC,LO,GO,NO > >::operator =(Tpetra::MatrixMarket::Writer< Tpetra::CrsMatrix< SC,LO,GO,NO > > const &)", SWIG_IndexError, e.what(), return ); - } - catch (const std::exception& e) - { - // Store a C++ exception - SWIG_exception_impl("Tpetra::MatrixMarket::Writer< Tpetra::CrsMatrix< SC,LO,GO,NO > >::operator =(Tpetra::MatrixMarket::Writer< Tpetra::CrsMatrix< SC,LO,GO,NO > > const &)", SWIG_RuntimeError, e.what(), return ); - } - catch (...) - { - SWIG_exception_impl("Tpetra::MatrixMarket::Writer< Tpetra::CrsMatrix< SC,LO,GO,NO > >::operator =(Tpetra::MatrixMarket::Writer< Tpetra::CrsMatrix< SC,LO,GO,NO > > const &)", SWIG_UnknownError, "An unknown exception occurred", return ); - } - } + SWIG_check_sp_nonnull(farg2, "Tpetra::MatrixMarket::Writer< Tpetra::CrsMatrix< SC,LO,GO,NO > > *", "TpetraWriter", "Tpetra::MatrixMarket::Writer< Tpetra::CrsMatrix< SC,LO,GO,NO > >::operator =(Tpetra::MatrixMarket::Writer< Tpetra::CrsMatrix< SC,LO,GO,NO > > &)", return ) + smartarg2 = static_cast< Teuchos::RCP< Tpetra::MatrixMarket::Writer > >* >(farg2->cptr); + arg2 = const_cast< Tpetra::MatrixMarket::Writer >* >(smartarg2->get()); + SWIG_assign > >, SWIGPOLICY_Tpetra__MatrixMarket__WriterT_Tpetra__CrsMatrixT_SC_LO_GO_NO_t_t>(farg1, *farg2); + } @@ -15500,7 +15165,5 @@ SWIGEXPORT void _wrap_TpetraMatrixMatrixAdd__SWIG_1(SwigClassWrapper const *farg } -#ifdef __cplusplus -} -#endif +} // extern diff --git a/src/utils/src/swig/forerrorFORTRAN_wrap.cxx b/src/utils/src/swig/forerrorFORTRAN_wrap.cxx index 45670c3e..2a3a2f41 100644 --- a/src/utils/src/swig/forerrorFORTRAN_wrap.cxx +++ b/src/utils/src/swig/forerrorFORTRAN_wrap.cxx @@ -311,9 +311,7 @@ SWIGEXPORT void SWIG_store_exception(const char *decl, } } -#ifdef __cplusplus extern "C" { -#endif SWIGEXPORT SwigArrayWrapper _wrap_fortrilinos_get_serr() { SwigArrayWrapper fresult ; char *result = 0 ; @@ -325,7 +323,5 @@ SWIGEXPORT SwigArrayWrapper _wrap_fortrilinos_get_serr() { } -#ifdef __cplusplus -} -#endif +} // extern diff --git a/swig_hash b/swig_hash index d0a89e3f..0b66f110 100644 --- a/swig_hash +++ b/swig_hash @@ -1 +1 @@ -73c02247682d52d61ae6bd48b4c88ea4cdb803d9 +cbc70530881be3d3ae0414afd44d4b98f4ee3b00 From 0e10afce58c6aa27d6800b301295e07b21d1f0c6 Mon Sep 17 00:00:00 2001 From: Seth R Johnson Date: Thu, 9 May 2019 12:22:35 -0400 Subject: [PATCH 35/40] Update to latest SWIG master --- src/tpetra/src/swig/fortpetra.F90 | 34 +++++++++---------- src/tpetra/src/swig/fortpetraFORTRAN_wrap.cxx | 24 ++++++------- swig_hash | 1 + 3 files changed, 30 insertions(+), 29 deletions(-) diff --git a/src/tpetra/src/swig/fortpetra.F90 b/src/tpetra/src/swig/fortpetra.F90 index 811d16f1..4da96e94 100644 --- a/src/tpetra/src/swig/fortpetra.F90 +++ b/src/tpetra/src/swig/fortpetra.F90 @@ -109,7 +109,7 @@ module fortpetra public :: combineModeToString integer(C_LONG_LONG), parameter, public :: TPETRA_GLOBAL_INVALID = -1_C_LONG_LONG integer(C_INT), parameter, public :: TPETRA_LOCAL_INVALID = 0_C_INT - type, public :: SWIGTYPE_Teuchos__RCPT_Kokkos__Compat__KokkosSerialWrapper9ZCDM + type, public :: SWIGTYPE_p_Teuchos__RCPT_Kokkos__Compat__KokkosSerialWrappTF2SL type(SwigClassWrapper), public :: swigdata end type ! class Tpetra::Map< LO,GO,NO > @@ -158,7 +158,7 @@ module fortpetra module procedure swigf_new_TpetraMap__SWIG_6 module procedure swigf_new_TpetraMap__SWIG_7 end interface - type, public :: SWIGTYPE_std__ostream + type, public :: SWIGTYPE_p_std__ostream type(SwigClassWrapper), public :: swigdata end type ! class Tpetra::Import< LO,GO,NO > @@ -211,7 +211,7 @@ module fortpetra module procedure swigf_new_TpetraExport__SWIG_2 module procedure swigf_new_TpetraExport__SWIG_3 end interface - type, public :: SWIGTYPE_Kokkos__ViewT_double_p_Kokkos__HostSpace_t + type, public :: SWIGTYPE_p_Kokkos__ViewT_double_p_Kokkos__HostSpace_t type(SwigClassWrapper), public :: swigdata end type ! class Tpetra::MultiVector< SC,LO,GO,NO > @@ -476,10 +476,10 @@ module fortpetra module procedure swigf_new_TpetraCrsGraph__SWIG_12 module procedure swigf_new_TpetraCrsGraph__SWIG_13 end interface - type, public :: SWIGTYPE_KokkosSparse__CrsMatrixT_Tpetra__CrsMatrixT_doub1E12GN + type, public :: SWIGTYPE_p_KokkosSparse__CrsMatrixT_Tpetra__CrsMatrixT_douC8X8I type(SwigClassWrapper), public :: swigdata end type - type, public :: SWIGTYPE_Teuchos__ArrayRCPT_unsigned_long_t + type, public :: SWIGTYPE_p_Teuchos__ArrayRCPT_unsigned_long_t type(SwigClassWrapper), public :: swigdata end type ! class Tpetra::CrsMatrix< SC,LO,GO,NO > @@ -4427,7 +4427,7 @@ function swigf_new_TpetraMap__SWIG_0(numglobalelements, comm, lg, node) & integer(C_LONG), intent(in) :: numglobalelements class(TeuchosComm), intent(in) :: comm integer(TpetraLocalGlobal), intent(in) :: lg -class(SWIGTYPE_Teuchos__RCPT_Kokkos__Compat__KokkosSerialWrapper9ZCDM), intent(in) :: node +class(SWIGTYPE_p_Teuchos__RCPT_Kokkos__Compat__KokkosSerialWrappTF2SL), intent(in) :: node type(SwigClassWrapper) :: fresult integer(C_LONG) :: farg1 type(SwigClassWrapper) :: farg3 @@ -4484,7 +4484,7 @@ function swigf_new_TpetraMap__SWIG_3(numglobalelements, numlocalelements, comm, integer(C_LONG), intent(in) :: numglobalelements integer, intent(in) :: numlocalelements class(TeuchosComm), intent(in) :: comm -class(SWIGTYPE_Teuchos__RCPT_Kokkos__Compat__KokkosSerialWrapper9ZCDM), intent(in) :: node +class(SWIGTYPE_p_Teuchos__RCPT_Kokkos__Compat__KokkosSerialWrappTF2SL), intent(in) :: node type(SwigClassWrapper) :: fresult integer(C_LONG) :: farg1 integer(C_INT) :: farg2 @@ -4526,7 +4526,7 @@ function swigf_new_TpetraMap__SWIG_5(numglobalelements, indexlist, comm, node) & integer(C_LONG_LONG), dimension(:), target :: indexlist integer(C_LONG_LONG), pointer :: farg2_view class(TeuchosComm), intent(in) :: comm -class(SWIGTYPE_Teuchos__RCPT_Kokkos__Compat__KokkosSerialWrapper9ZCDM), intent(in) :: node +class(SWIGTYPE_p_Teuchos__RCPT_Kokkos__Compat__KokkosSerialWrappTF2SL), intent(in) :: node type(SwigClassWrapper) :: fresult integer(C_LONG) :: farg1 type(SwigArrayWrapper) :: farg2 @@ -5289,7 +5289,7 @@ function swigf_TpetraImport_createRemoteOnlyImport(self, remotetarget) & subroutine swigf_TpetraImport_print(self, os) use, intrinsic :: ISO_C_BINDING class(TpetraImport), intent(in) :: self -class(SWIGTYPE_std__ostream), intent(in) :: os +class(SWIGTYPE_p_std__ostream), intent(in) :: os type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 @@ -5492,7 +5492,7 @@ function swigf_TpetraExport_isLocallyComplete(self) & subroutine swigf_TpetraExport_print(self, os) use, intrinsic :: ISO_C_BINDING class(TpetraExport), intent(in) :: self -class(SWIGTYPE_std__ostream), intent(in) :: os +class(SWIGTYPE_p_std__ostream), intent(in) :: os type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 @@ -6159,7 +6159,7 @@ subroutine swigf_TpetraMultiVector_dot__SWIG_3(self, a, norms) use, intrinsic :: ISO_C_BINDING class(TpetraMultiVector), intent(in) :: self class(TpetraMultiVector), intent(in) :: a -class(SWIGTYPE_Kokkos__ViewT_double_p_Kokkos__HostSpace_t), intent(in) :: norms +class(SWIGTYPE_p_Kokkos__ViewT_double_p_Kokkos__HostSpace_t), intent(in) :: norms type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 type(SwigClassWrapper) :: farg3 @@ -6286,7 +6286,7 @@ subroutine swigf_TpetraMultiVector_update__SWIG_1(self, alpha, a, beta, b, gamma subroutine swigf_TpetraMultiVector_norm1__SWIG_1(self, norms) use, intrinsic :: ISO_C_BINDING class(TpetraMultiVector), intent(in) :: self -class(SWIGTYPE_Kokkos__ViewT_double_p_Kokkos__HostSpace_t), intent(in) :: norms +class(SWIGTYPE_p_Kokkos__ViewT_double_p_Kokkos__HostSpace_t), intent(in) :: norms type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 @@ -6318,7 +6318,7 @@ subroutine swigf_TpetraMultiVector_norm1__SWIG_3(self, norms) subroutine swigf_TpetraMultiVector_norm2__SWIG_1(self, norms) use, intrinsic :: ISO_C_BINDING class(TpetraMultiVector), intent(in) :: self -class(SWIGTYPE_Kokkos__ViewT_double_p_Kokkos__HostSpace_t), intent(in) :: norms +class(SWIGTYPE_p_Kokkos__ViewT_double_p_Kokkos__HostSpace_t), intent(in) :: norms type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 @@ -6350,7 +6350,7 @@ subroutine swigf_TpetraMultiVector_norm2__SWIG_3(self, norms) subroutine swigf_TpetraMultiVector_normInf__SWIG_1(self, norms) use, intrinsic :: ISO_C_BINDING class(TpetraMultiVector), intent(in) :: self -class(SWIGTYPE_Kokkos__ViewT_double_p_Kokkos__HostSpace_t), intent(in) :: norms +class(SWIGTYPE_p_Kokkos__ViewT_double_p_Kokkos__HostSpace_t), intent(in) :: norms type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 @@ -8909,7 +8909,7 @@ function swigf_new_TpetraCrsMatrix__SWIG_14(graph, values, params) & use, intrinsic :: ISO_C_BINDING type(TpetraCrsMatrix) :: self class(TpetraCrsGraph), intent(in) :: graph -class(SWIGTYPE_KokkosSparse__CrsMatrixT_Tpetra__CrsMatrixT_doub1E12GN), intent(in) :: values +class(SWIGTYPE_p_KokkosSparse__CrsMatrixT_Tpetra__CrsMatrixT_douC8X8I), intent(in) :: values class(ParameterList), intent(in) :: params type(SwigClassWrapper) :: fresult type(SwigClassWrapper) :: farg1 @@ -8928,7 +8928,7 @@ function swigf_new_TpetraCrsMatrix__SWIG_15(graph, values) & use, intrinsic :: ISO_C_BINDING type(TpetraCrsMatrix) :: self class(TpetraCrsGraph), intent(in) :: graph -class(SWIGTYPE_KokkosSparse__CrsMatrixT_Tpetra__CrsMatrixT_doub1E12GN), intent(in) :: values +class(SWIGTYPE_p_KokkosSparse__CrsMatrixT_Tpetra__CrsMatrixT_douC8X8I), intent(in) :: values type(SwigClassWrapper) :: fresult type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 @@ -10055,7 +10055,7 @@ subroutine swigf_TpetraCrsMatrix_getGlobalRowView(self, globalrow, indices, valu subroutine swigf_TpetraCrsMatrix_getLocalDiagOffsets(self, offsets) use, intrinsic :: ISO_C_BINDING class(TpetraCrsMatrix), intent(in) :: self -class(SWIGTYPE_Teuchos__ArrayRCPT_unsigned_long_t), intent(in) :: offsets +class(SWIGTYPE_p_Teuchos__ArrayRCPT_unsigned_long_t), intent(in) :: offsets type(SwigClassWrapper) :: farg1 type(SwigClassWrapper) :: farg2 diff --git a/src/tpetra/src/swig/fortpetraFORTRAN_wrap.cxx b/src/tpetra/src/swig/fortpetraFORTRAN_wrap.cxx index 9a14e385..c8632b04 100644 --- a/src/tpetra/src/swig/fortpetraFORTRAN_wrap.cxx +++ b/src/tpetra/src/swig/fortpetraFORTRAN_wrap.cxx @@ -747,7 +747,7 @@ SWIGEXPORT SwigClassWrapper _wrap_new_TpetraMap__SWIG_0(long const *farg1, SwigC arg1 = static_cast< Tpetra::global_size_t >(*farg1); arg3 = farg3->cptr ? static_cast< Teuchos::RCP< Teuchos::Comm< int > const > * >(farg3->cptr) : &tempnull3; arg4 = static_cast< Tpetra::LocalGlobal >(*farg4); - SWIG_check_nonnull(*farg5, "Teuchos::RCP< Kokkos::Compat::KokkosSerialWrapperNode > const &", "SWIGTYPE_Teuchos__RCPT_Kokkos__Compat__KokkosSerialWrapper9ZCDM", "Tpetra::Map< LO,GO,NO >::Map(Tpetra::global_size_t,long long,Teuchos::RCP< Teuchos::Comm< int > const > const &,Tpetra::LocalGlobal,Teuchos::RCP< Kokkos::Compat::KokkosSerialWrapperNode > const &)", return SwigClassWrapper_uninitialized()); + SWIG_check_nonnull(*farg5, "Teuchos::RCP< Kokkos::Compat::KokkosSerialWrapperNode > const &", "SWIGTYPE_p_Teuchos__RCPT_Kokkos__Compat__KokkosSerialWrappTF2SL", "Tpetra::Map< LO,GO,NO >::Map(Tpetra::global_size_t,long long,Teuchos::RCP< Teuchos::Comm< int > const > const &,Tpetra::LocalGlobal,Teuchos::RCP< Kokkos::Compat::KokkosSerialWrapperNode > const &)", return SwigClassWrapper_uninitialized()); arg5 = static_cast< Teuchos::RCP< Kokkos::Compat::KokkosSerialWrapperNode > * >(farg5->cptr); { // Make sure no unhandled exceptions exist before performing a new action @@ -880,7 +880,7 @@ SWIGEXPORT SwigClassWrapper _wrap_new_TpetraMap__SWIG_3(long const *farg1, int c arg1 = static_cast< Tpetra::global_size_t >(*farg1); arg2 = static_cast< size_t >(*farg2); arg4 = farg4->cptr ? static_cast< Teuchos::RCP< Teuchos::Comm< int > const > * >(farg4->cptr) : &tempnull4; - SWIG_check_nonnull(*farg5, "Teuchos::RCP< Kokkos::Compat::KokkosSerialWrapperNode > const &", "SWIGTYPE_Teuchos__RCPT_Kokkos__Compat__KokkosSerialWrapper9ZCDM", "Tpetra::Map< LO,GO,NO >::Map(Tpetra::global_size_t,size_t,long long,Teuchos::RCP< Teuchos::Comm< int > const > const &,Teuchos::RCP< Kokkos::Compat::KokkosSerialWrapperNode > const &)", return SwigClassWrapper_uninitialized()); + SWIG_check_nonnull(*farg5, "Teuchos::RCP< Kokkos::Compat::KokkosSerialWrapperNode > const &", "SWIGTYPE_p_Teuchos__RCPT_Kokkos__Compat__KokkosSerialWrappTF2SL", "Tpetra::Map< LO,GO,NO >::Map(Tpetra::global_size_t,size_t,long long,Teuchos::RCP< Teuchos::Comm< int > const > const &,Teuchos::RCP< Kokkos::Compat::KokkosSerialWrapperNode > const &)", return SwigClassWrapper_uninitialized()); arg5 = static_cast< Teuchos::RCP< Kokkos::Compat::KokkosSerialWrapperNode > * >(farg5->cptr); { // Make sure no unhandled exceptions exist before performing a new action @@ -973,7 +973,7 @@ SWIGEXPORT SwigClassWrapper _wrap_new_TpetraMap__SWIG_5(long const *farg1, SwigA tmpview2 = Teuchos::ArrayView(static_cast(farg2->data), farg2->size); arg2 = &tmpview2; arg4 = farg4->cptr ? static_cast< Teuchos::RCP< Teuchos::Comm< int > const > * >(farg4->cptr) : &tempnull4; - SWIG_check_nonnull(*farg5, "Teuchos::RCP< Kokkos::Compat::KokkosSerialWrapperNode > const &", "SWIGTYPE_Teuchos__RCPT_Kokkos__Compat__KokkosSerialWrapper9ZCDM", "Tpetra::Map< LO,GO,NO >::Map(Tpetra::global_size_t const,Teuchos::ArrayView< long long const > const &,long long const,Teuchos::RCP< Teuchos::Comm< int > const > const &,Teuchos::RCP< Kokkos::Compat::KokkosSerialWrapperNode > const &)", return SwigClassWrapper_uninitialized()); + SWIG_check_nonnull(*farg5, "Teuchos::RCP< Kokkos::Compat::KokkosSerialWrapperNode > const &", "SWIGTYPE_p_Teuchos__RCPT_Kokkos__Compat__KokkosSerialWrappTF2SL", "Tpetra::Map< LO,GO,NO >::Map(Tpetra::global_size_t const,Teuchos::ArrayView< long long const > const &,long long const,Teuchos::RCP< Teuchos::Comm< int > const > const &,Teuchos::RCP< Kokkos::Compat::KokkosSerialWrapperNode > const &)", return SwigClassWrapper_uninitialized()); arg5 = static_cast< Teuchos::RCP< Kokkos::Compat::KokkosSerialWrapperNode > * >(farg5->cptr); { // Make sure no unhandled exceptions exist before performing a new action @@ -2774,7 +2774,7 @@ SWIGEXPORT void _wrap_TpetraImport_print(SwigClassWrapper const *farg1, SwigClas smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); arg1 = smartarg1 ? const_cast< Tpetra::Import* >(smartarg1->get()) : NULL; - SWIG_check_mutable_nonnull(*farg2, "std::ostream &", "SWIGTYPE_std__ostream", "Tpetra::Import< LO,GO,NO >::print(std::ostream &) const", return ); + SWIG_check_mutable_nonnull(*farg2, "std::ostream &", "SWIGTYPE_p_std__ostream", "Tpetra::Import< LO,GO,NO >::print(std::ostream &) const", return ); arg2 = static_cast< std::ostream * >(farg2->cptr); { // Make sure no unhandled exceptions exist before performing a new action @@ -3303,7 +3303,7 @@ SWIGEXPORT void _wrap_TpetraExport_print(SwigClassWrapper const *farg1, SwigClas smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); arg1 = smartarg1 ? const_cast< Tpetra::Export* >(smartarg1->get()) : NULL; - SWIG_check_mutable_nonnull(*farg2, "std::ostream &", "SWIGTYPE_std__ostream", "Tpetra::Export< LO,GO,NO >::print(std::ostream &) const", return ); + SWIG_check_mutable_nonnull(*farg2, "std::ostream &", "SWIGTYPE_p_std__ostream", "Tpetra::Export< LO,GO,NO >::print(std::ostream &) const", return ); arg2 = static_cast< std::ostream * >(farg2->cptr); { // Make sure no unhandled exceptions exist before performing a new action @@ -4824,7 +4824,7 @@ SWIGEXPORT void _wrap_TpetraMultiVector_dot__SWIG_3(SwigClassWrapper const *farg SWIG_check_sp_nonnull(farg2, "Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > *", "TpetraMultiVector", "Tpetra::MultiVector< SC,LO,GO,NO >::dot(Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &,Kokkos::View< Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::dot_type *,Kokkos::HostSpace > const &) const", return ) smartarg2 = static_cast< Teuchos::RCP >* >(farg2->cptr); arg2 = const_cast< Tpetra::MultiVector* >(smartarg2->get()); - SWIG_check_nonnull(*farg3, "Kokkos::View< Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::dot_type *,Kokkos::HostSpace > const &", "SWIGTYPE_Kokkos__ViewT_double_p_Kokkos__HostSpace_t", "Tpetra::MultiVector< SC,LO,GO,NO >::dot(Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &,Kokkos::View< Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::dot_type *,Kokkos::HostSpace > const &) const", return ); + SWIG_check_nonnull(*farg3, "Kokkos::View< Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::dot_type *,Kokkos::HostSpace > const &", "SWIGTYPE_p_Kokkos__ViewT_double_p_Kokkos__HostSpace_t", "Tpetra::MultiVector< SC,LO,GO,NO >::dot(Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &,Kokkos::View< Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::dot_type *,Kokkos::HostSpace > const &) const", return ); arg3 = static_cast< Kokkos::View< Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::dot_type *,Kokkos::HostSpace > * >(farg3->cptr); { // Make sure no unhandled exceptions exist before performing a new action @@ -5145,7 +5145,7 @@ SWIGEXPORT void _wrap_TpetraMultiVector_norm1__SWIG_1(SwigClassWrapper const *fa smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); arg1 = smartarg1 ? const_cast< Tpetra::MultiVector* >(smartarg1->get()) : NULL; - SWIG_check_nonnull(*farg2, "Kokkos::View< Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::mag_type *,Kokkos::HostSpace > const &", "SWIGTYPE_Kokkos__ViewT_double_p_Kokkos__HostSpace_t", "Tpetra::MultiVector< SC,LO,GO,NO >::norm1(Kokkos::View< Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::mag_type *,Kokkos::HostSpace > const &) const", return ); + SWIG_check_nonnull(*farg2, "Kokkos::View< Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::mag_type *,Kokkos::HostSpace > const &", "SWIGTYPE_p_Kokkos__ViewT_double_p_Kokkos__HostSpace_t", "Tpetra::MultiVector< SC,LO,GO,NO >::norm1(Kokkos::View< Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::mag_type *,Kokkos::HostSpace > const &) const", return ); arg2 = static_cast< Kokkos::View< Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::mag_type *,Kokkos::HostSpace > * >(farg2->cptr); { // Make sure no unhandled exceptions exist before performing a new action @@ -5216,7 +5216,7 @@ SWIGEXPORT void _wrap_TpetraMultiVector_norm2__SWIG_1(SwigClassWrapper const *fa smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); arg1 = smartarg1 ? const_cast< Tpetra::MultiVector* >(smartarg1->get()) : NULL; - SWIG_check_nonnull(*farg2, "Kokkos::View< Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::mag_type *,Kokkos::HostSpace > const &", "SWIGTYPE_Kokkos__ViewT_double_p_Kokkos__HostSpace_t", "Tpetra::MultiVector< SC,LO,GO,NO >::norm2(Kokkos::View< Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::mag_type *,Kokkos::HostSpace > const &) const", return ); + SWIG_check_nonnull(*farg2, "Kokkos::View< Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::mag_type *,Kokkos::HostSpace > const &", "SWIGTYPE_p_Kokkos__ViewT_double_p_Kokkos__HostSpace_t", "Tpetra::MultiVector< SC,LO,GO,NO >::norm2(Kokkos::View< Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::mag_type *,Kokkos::HostSpace > const &) const", return ); arg2 = static_cast< Kokkos::View< Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::mag_type *,Kokkos::HostSpace > * >(farg2->cptr); { // Make sure no unhandled exceptions exist before performing a new action @@ -5287,7 +5287,7 @@ SWIGEXPORT void _wrap_TpetraMultiVector_normInf__SWIG_1(SwigClassWrapper const * smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); arg1 = smartarg1 ? const_cast< Tpetra::MultiVector* >(smartarg1->get()) : NULL; - SWIG_check_nonnull(*farg2, "Kokkos::View< Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::mag_type *,Kokkos::HostSpace > const &", "SWIGTYPE_Kokkos__ViewT_double_p_Kokkos__HostSpace_t", "Tpetra::MultiVector< SC,LO,GO,NO >::normInf(Kokkos::View< Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::mag_type *,Kokkos::HostSpace > const &) const", return ); + SWIG_check_nonnull(*farg2, "Kokkos::View< Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::mag_type *,Kokkos::HostSpace > const &", "SWIGTYPE_p_Kokkos__ViewT_double_p_Kokkos__HostSpace_t", "Tpetra::MultiVector< SC,LO,GO,NO >::normInf(Kokkos::View< Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::mag_type *,Kokkos::HostSpace > const &) const", return ); arg2 = static_cast< Kokkos::View< Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::mag_type *,Kokkos::HostSpace > * >(farg2->cptr); { // Make sure no unhandled exceptions exist before performing a new action @@ -10593,7 +10593,7 @@ SWIGEXPORT SwigClassWrapper _wrap_new_TpetraCrsMatrix__SWIG_14(SwigClassWrapper Tpetra::CrsMatrix< SC,LO,GO,NO > *result = 0 ; arg1 = farg1->cptr ? static_cast< Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::crs_graph_type const > * >(farg1->cptr) : &tempnull1; - SWIG_check_nonnull(*farg2, "Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::local_matrix_type::values_type const &", "SWIGTYPE_KokkosSparse__CrsMatrixT_Tpetra__CrsMatrixT_doub1E12GN", "Tpetra::CrsMatrix< SC,LO,GO,NO >::CrsMatrix(Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::crs_graph_type const > const &,Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::local_matrix_type::values_type const &,Teuchos::RCP< Teuchos::ParameterList > const &)", return SwigClassWrapper_uninitialized()); + SWIG_check_nonnull(*farg2, "Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::local_matrix_type::values_type const &", "SWIGTYPE_p_KokkosSparse__CrsMatrixT_Tpetra__CrsMatrixT_douC8X8I", "Tpetra::CrsMatrix< SC,LO,GO,NO >::CrsMatrix(Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::crs_graph_type const > const &,Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::local_matrix_type::values_type const &,Teuchos::RCP< Teuchos::ParameterList > const &)", return SwigClassWrapper_uninitialized()); arg2 = static_cast< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::local_matrix_type::values_type * >(farg2->cptr); arg3 = farg3->cptr ? static_cast< Teuchos::RCP< Teuchos::ParameterList > * >(farg3->cptr) : &tempnull3; { @@ -10633,7 +10633,7 @@ SWIGEXPORT SwigClassWrapper _wrap_new_TpetraCrsMatrix__SWIG_15(SwigClassWrapper Tpetra::CrsMatrix< SC,LO,GO,NO > *result = 0 ; arg1 = farg1->cptr ? static_cast< Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::crs_graph_type const > * >(farg1->cptr) : &tempnull1; - SWIG_check_nonnull(*farg2, "Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::local_matrix_type::values_type const &", "SWIGTYPE_KokkosSparse__CrsMatrixT_Tpetra__CrsMatrixT_doub1E12GN", "Tpetra::CrsMatrix< SC,LO,GO,NO >::CrsMatrix(Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::crs_graph_type const > const &,Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::local_matrix_type::values_type const &)", return SwigClassWrapper_uninitialized()); + SWIG_check_nonnull(*farg2, "Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::local_matrix_type::values_type const &", "SWIGTYPE_p_KokkosSparse__CrsMatrixT_Tpetra__CrsMatrixT_douC8X8I", "Tpetra::CrsMatrix< SC,LO,GO,NO >::CrsMatrix(Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::crs_graph_type const > const &,Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::local_matrix_type::values_type const &)", return SwigClassWrapper_uninitialized()); arg2 = static_cast< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::local_matrix_type::values_type * >(farg2->cptr); { // Make sure no unhandled exceptions exist before performing a new action @@ -12954,7 +12954,7 @@ SWIGEXPORT void _wrap_TpetraCrsMatrix_getLocalDiagOffsets(SwigClassWrapper const smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); arg1 = smartarg1 ? const_cast< Tpetra::CrsMatrix* >(smartarg1->get()) : NULL; - SWIG_check_mutable_nonnull(*farg2, "Teuchos::ArrayRCP< std::size_t > &", "SWIGTYPE_Teuchos__ArrayRCPT_unsigned_long_t", "Tpetra::CrsMatrix< SC,LO,GO,NO >::getLocalDiagOffsets(Teuchos::ArrayRCP< std::size_t > &) const", return ); + SWIG_check_mutable_nonnull(*farg2, "Teuchos::ArrayRCP< std::size_t > &", "SWIGTYPE_p_Teuchos__ArrayRCPT_unsigned_long_t", "Tpetra::CrsMatrix< SC,LO,GO,NO >::getLocalDiagOffsets(Teuchos::ArrayRCP< std::size_t > &) const", return ); arg2 = static_cast< Teuchos::ArrayRCP< std::size_t > * >(farg2->cptr); { // Make sure no unhandled exceptions exist before performing a new action diff --git a/swig_hash b/swig_hash index 0b66f110..b887b0d5 100644 --- a/swig_hash +++ b/swig_hash @@ -1 +1,2 @@ cbc70530881be3d3ae0414afd44d4b98f4ee3b00 +f7b89565dfc953a5b5c5b8c580d96789e8a95948 From 6f96b2c2d777f3de4c730f3377b01e60d7fbe7ee Mon Sep 17 00:00:00 2001 From: Seth R Johnson Date: Thu, 9 May 2019 12:29:11 -0400 Subject: [PATCH 36/40] Hide functions that use opaque data types --- src/tpetra/src/Tpetra_Map.i | 5 +- src/tpetra/src/fortpetra.i | 3 + src/tpetra/src/swig/fortpetra.F90 | 364 +------------ src/tpetra/src/swig/fortpetraFORTRAN_wrap.cxx | 478 +----------------- swig_hash | 1 + 5 files changed, 20 insertions(+), 831 deletions(-) diff --git a/src/tpetra/src/Tpetra_Map.i b/src/tpetra/src/Tpetra_Map.i index 84d05cec..a79e33f3 100644 --- a/src/tpetra/src/Tpetra_Map.i +++ b/src/tpetra/src/Tpetra_Map.i @@ -21,6 +21,7 @@ // ======================================================================= // Ignore permanently // ======================================================================= +%fortranonlywrapped Tpetra::Map::Map; %ignore Tpetra::Map::Map(const global_size_t numGlobalElements, const GlobalOrdinal indexList[], const LocalOrdinal indexListSize, const GlobalOrdinal indexBase, const Teuchos::RCP< const Teuchos::Comm< int > > &comm); // superseded by Teuchos::ArrayView version @@ -28,10 +29,6 @@ // ======================================================================= // Postpone temporarily // ======================================================================= -%ignore Tpetra::Map::Map(const global_size_t numGlobalElements, - const Kokkos::View& indexList, - const GlobalOrdinal indexBase, - const Teuchos::RCP >& comm); // needs Kokkos::View %ignore Tpetra::Map::getLocalMap; // no need to expose this yet %ignore Tpetra::Map::getMyGlobalIndices; // return type is not exposed externally, requires using `auto`; for now, use getNodeElementList diff --git a/src/tpetra/src/fortpetra.i b/src/tpetra/src/fortpetra.i index 44c10ae1..7b0fccde 100644 --- a/src/tpetra/src/fortpetra.i +++ b/src/tpetra/src/fortpetra.i @@ -11,6 +11,9 @@ %import +// Hide functions that use any unknown types (Kokkos, std::ostream, etc.) +%fortranonlywrapped; + // ======================================================================= // Type definition // ======================================================================= diff --git a/src/tpetra/src/swig/fortpetra.F90 b/src/tpetra/src/swig/fortpetra.F90 index 4da96e94..b894b637 100644 --- a/src/tpetra/src/swig/fortpetra.F90 +++ b/src/tpetra/src/swig/fortpetra.F90 @@ -109,9 +109,6 @@ module fortpetra public :: combineModeToString integer(C_LONG_LONG), parameter, public :: TPETRA_GLOBAL_INVALID = -1_C_LONG_LONG integer(C_INT), parameter, public :: TPETRA_LOCAL_INVALID = 0_C_INT - type, public :: SWIGTYPE_p_Teuchos__RCPT_Kokkos__Compat__KokkosSerialWrappTF2SL - type(SwigClassWrapper), public :: swigdata - end type ! class Tpetra::Map< LO,GO,NO > type, public :: TpetraMap type(SwigClassWrapper), public :: swigdata @@ -149,18 +146,12 @@ module fortpetra generic :: getRemoteIndexList => swigf_TpetraMap_getRemoteIndexList__SWIG_0, swigf_TpetraMap_getRemoteIndexList__SWIG_1 end type TpetraMap interface TpetraMap - module procedure swigf_new_TpetraMap__SWIG_0 module procedure swigf_new_TpetraMap__SWIG_1 module procedure swigf_new_TpetraMap__SWIG_2 - module procedure swigf_new_TpetraMap__SWIG_3 module procedure swigf_new_TpetraMap__SWIG_4 - module procedure swigf_new_TpetraMap__SWIG_5 - module procedure swigf_new_TpetraMap__SWIG_6 module procedure swigf_new_TpetraMap__SWIG_7 + module procedure swigf_new_TpetraMap__SWIG_8 end interface - type, public :: SWIGTYPE_p_std__ostream - type(SwigClassWrapper), public :: swigdata - end type ! class Tpetra::Import< LO,GO,NO > type, public :: TpetraImport type(SwigClassWrapper), public :: swigdata @@ -177,7 +168,6 @@ module fortpetra procedure, private :: swigf_TpetraImport_setUnion__SWIG_0 procedure, private :: swigf_TpetraImport_setUnion__SWIG_1 procedure :: createRemoteOnlyImport => swigf_TpetraImport_createRemoteOnlyImport - procedure :: print => swigf_TpetraImport_print procedure, private :: swigf_TpetraImport_op_assign__ generic :: assignment(=) => swigf_TpetraImport_op_assign__ generic :: setUnion => swigf_TpetraImport_setUnion__SWIG_0, swigf_TpetraImport_setUnion__SWIG_1 @@ -201,7 +191,6 @@ module fortpetra procedure :: getSourceMap => swigf_TpetraExport_getSourceMap procedure :: getTargetMap => swigf_TpetraExport_getTargetMap procedure :: isLocallyComplete => swigf_TpetraExport_isLocallyComplete - procedure :: print => swigf_TpetraExport_print procedure, private :: swigf_TpetraExport_op_assign__ generic :: assignment(=) => swigf_TpetraExport_op_assign__ end type TpetraExport @@ -211,9 +200,6 @@ module fortpetra module procedure swigf_new_TpetraExport__SWIG_2 module procedure swigf_new_TpetraExport__SWIG_3 end interface - type, public :: SWIGTYPE_p_Kokkos__ViewT_double_p_Kokkos__HostSpace_t - type(SwigClassWrapper), public :: swigdata - end type ! class Tpetra::MultiVector< SC,LO,GO,NO > type, public :: TpetraMultiVector type(SwigClassWrapper), public :: swigdata @@ -248,7 +234,6 @@ module fortpetra procedure :: modify_device => swigf_TpetraMultiVector_modify_device procedure :: modify_host => swigf_TpetraMultiVector_modify_host procedure, private :: swigf_TpetraMultiVector_dot__SWIG_0 - procedure, private :: swigf_TpetraMultiVector_dot__SWIG_3 procedure :: abs => swigf_TpetraMultiVector_abs procedure :: reciprocal => swigf_TpetraMultiVector_reciprocal procedure, private :: swigf_TpetraMultiVector_scale__SWIG_0 @@ -256,11 +241,8 @@ module fortpetra procedure, private :: swigf_TpetraMultiVector_scale__SWIG_2 procedure, private :: swigf_TpetraMultiVector_update__SWIG_0 procedure, private :: swigf_TpetraMultiVector_update__SWIG_1 - procedure, private :: swigf_TpetraMultiVector_norm1__SWIG_1 procedure, private :: swigf_TpetraMultiVector_norm1__SWIG_3 - procedure, private :: swigf_TpetraMultiVector_norm2__SWIG_1 procedure, private :: swigf_TpetraMultiVector_norm2__SWIG_3 - procedure, private :: swigf_TpetraMultiVector_normInf__SWIG_1 procedure, private :: swigf_TpetraMultiVector_normInf__SWIG_3 procedure :: meanValue => swigf_TpetraMultiVector_meanValue procedure :: multiply => swigf_TpetraMultiVector_multiply @@ -281,18 +263,18 @@ module fortpetra procedure, private :: swigf_TpetraMultiVector_op_assign__ generic :: assignment(=) => swigf_TpetraMultiVector_op_assign__ generic :: randomize => swigf_TpetraMultiVector_randomize__SWIG_0, swigf_TpetraMultiVector_randomize__SWIG_1 - generic :: normInf => swigf_TpetraMultiVector_normInf__SWIG_1, swigf_TpetraMultiVector_normInf__SWIG_3 + generic :: normInf => swigf_TpetraMultiVector_normInf__SWIG_3 generic :: doImport => swigf_TpetraMultiVector_doImport__SWIG_0, swigf_TpetraMultiVector_doImport__SWIG_1 generic :: sumIntoGlobalValue => swigf_TpetraMultiVector_sumIntoGlobalValue__SWIG_0, & swigf_TpetraMultiVector_sumIntoGlobalValue__SWIG_1 generic :: sumIntoLocalValue => swigf_TpetraMultiVector_sumIntoLocalValue__SWIG_0, & swigf_TpetraMultiVector_sumIntoLocalValue__SWIG_1 - generic :: dot => swigf_TpetraMultiVector_dot__SWIG_0, swigf_TpetraMultiVector_dot__SWIG_3 - generic :: norm1 => swigf_TpetraMultiVector_norm1__SWIG_1, swigf_TpetraMultiVector_norm1__SWIG_3 + generic :: dot => swigf_TpetraMultiVector_dot__SWIG_0 + generic :: norm1 => swigf_TpetraMultiVector_norm1__SWIG_3 generic :: doExport => swigf_TpetraMultiVector_doExport__SWIG_0, swigf_TpetraMultiVector_doExport__SWIG_1 generic :: scale => swigf_TpetraMultiVector_scale__SWIG_0, swigf_TpetraMultiVector_scale__SWIG_1, & swigf_TpetraMultiVector_scale__SWIG_2 - generic :: norm2 => swigf_TpetraMultiVector_norm2__SWIG_1, swigf_TpetraMultiVector_norm2__SWIG_3 + generic :: norm2 => swigf_TpetraMultiVector_norm2__SWIG_3 generic :: update => swigf_TpetraMultiVector_update__SWIG_0, swigf_TpetraMultiVector_update__SWIG_1 end type TpetraMultiVector interface TpetraMultiVector @@ -476,12 +458,6 @@ module fortpetra module procedure swigf_new_TpetraCrsGraph__SWIG_12 module procedure swigf_new_TpetraCrsGraph__SWIG_13 end interface - type, public :: SWIGTYPE_p_KokkosSparse__CrsMatrixT_Tpetra__CrsMatrixT_douC8X8I - type(SwigClassWrapper), public :: swigdata - end type - type, public :: SWIGTYPE_p_Teuchos__ArrayRCPT_unsigned_long_t - type(SwigClassWrapper), public :: swigdata - end type ! class Tpetra::CrsMatrix< SC,LO,GO,NO > type, public :: TpetraCrsMatrix type(SwigClassWrapper), public :: swigdata @@ -541,7 +517,6 @@ module fortpetra procedure :: getGlobalRowCopy => swigf_TpetraCrsMatrix_getGlobalRowCopy procedure :: getLocalRowCopy => swigf_TpetraCrsMatrix_getLocalRowCopy procedure :: getGlobalRowView => swigf_TpetraCrsMatrix_getGlobalRowView - procedure :: getLocalDiagOffsets => swigf_TpetraCrsMatrix_getLocalDiagOffsets procedure, private :: swigf_TpetraCrsMatrix_apply__SWIG_0 procedure, private :: swigf_TpetraCrsMatrix_apply__SWIG_1 procedure, private :: swigf_TpetraCrsMatrix_apply__SWIG_2 @@ -600,8 +575,6 @@ module fortpetra module procedure swigf_new_TpetraCrsMatrix__SWIG_11 module procedure swigf_new_TpetraCrsMatrix__SWIG_12 module procedure swigf_new_TpetraCrsMatrix__SWIG_13 - module procedure swigf_new_TpetraCrsMatrix__SWIG_14 - module procedure swigf_new_TpetraCrsMatrix__SWIG_15 module procedure swigf_new_TpetraCrsMatrix__SWIG_16 module procedure swigf_new_TpetraCrsMatrix__SWIG_17 end interface @@ -686,18 +659,6 @@ subroutine SWIG_free(cptr) & use, intrinsic :: ISO_C_BINDING type(C_PTR), value :: cptr end subroutine -function swigc_new_TpetraMap__SWIG_0(farg1, farg3, farg4, farg5) & -bind(C, name="_wrap_new_TpetraMap__SWIG_0") & -result(fresult) -use, intrinsic :: ISO_C_BINDING -import :: swigclasswrapper -integer(C_LONG), intent(in) :: farg1 -type(SwigClassWrapper) :: farg3 -integer(C_INT), intent(in) :: farg4 -type(SwigClassWrapper) :: farg5 -type(SwigClassWrapper) :: fresult -end function - function swigc_new_TpetraMap__SWIG_1(farg1, farg3, farg4) & bind(C, name="_wrap_new_TpetraMap__SWIG_1") & result(fresult) @@ -719,18 +680,6 @@ function swigc_new_TpetraMap__SWIG_2(farg1, farg3) & type(SwigClassWrapper) :: fresult end function -function swigc_new_TpetraMap__SWIG_3(farg1, farg2, farg4, farg5) & -bind(C, name="_wrap_new_TpetraMap__SWIG_3") & -result(fresult) -use, intrinsic :: ISO_C_BINDING -import :: swigclasswrapper -integer(C_LONG), intent(in) :: farg1 -integer(C_INT), intent(in) :: farg2 -type(SwigClassWrapper) :: farg4 -type(SwigClassWrapper) :: farg5 -type(SwigClassWrapper) :: fresult -end function - function swigc_new_TpetraMap__SWIG_4(farg1, farg2, farg4) & bind(C, name="_wrap_new_TpetraMap__SWIG_4") & result(fresult) @@ -742,21 +691,8 @@ function swigc_new_TpetraMap__SWIG_4(farg1, farg2, farg4) & type(SwigClassWrapper) :: fresult end function -function swigc_new_TpetraMap__SWIG_5(farg1, farg2, farg4, farg5) & -bind(C, name="_wrap_new_TpetraMap__SWIG_5") & -result(fresult) -use, intrinsic :: ISO_C_BINDING -import :: swigclasswrapper -import :: swigarraywrapper -integer(C_LONG), intent(in) :: farg1 -type(SwigArrayWrapper) :: farg2 -type(SwigClassWrapper) :: farg4 -type(SwigClassWrapper) :: farg5 -type(SwigClassWrapper) :: fresult -end function - -function swigc_new_TpetraMap__SWIG_6(farg1, farg2, farg4) & -bind(C, name="_wrap_new_TpetraMap__SWIG_6") & +function swigc_new_TpetraMap__SWIG_7(farg1, farg2, farg4) & +bind(C, name="_wrap_new_TpetraMap__SWIG_7") & result(fresult) use, intrinsic :: ISO_C_BINDING import :: swigclasswrapper @@ -767,8 +703,8 @@ function swigc_new_TpetraMap__SWIG_6(farg1, farg2, farg4) & type(SwigClassWrapper) :: fresult end function -function swigc_new_TpetraMap__SWIG_7() & -bind(C, name="_wrap_new_TpetraMap__SWIG_7") & +function swigc_new_TpetraMap__SWIG_8() & +bind(C, name="_wrap_new_TpetraMap__SWIG_8") & result(fresult) use, intrinsic :: ISO_C_BINDING import :: swigclasswrapper @@ -1197,14 +1133,6 @@ function swigc_TpetraImport_createRemoteOnlyImport(farg1, farg2) & type(SwigClassWrapper) :: fresult end function -subroutine swigc_TpetraImport_print(farg1, farg2) & -bind(C, name="_wrap_TpetraImport_print") -use, intrinsic :: ISO_C_BINDING -import :: swigclasswrapper -type(SwigClassWrapper) :: farg1 -type(SwigClassWrapper) :: farg2 -end subroutine - subroutine swigc_TpetraImport_op_assign__(farg1, farg2) & bind(C, name="_wrap_TpetraImport_op_assign__") use, intrinsic :: ISO_C_BINDING @@ -1330,14 +1258,6 @@ function swigc_TpetraExport_isLocallyComplete(farg1) & integer(C_INT) :: fresult end function -subroutine swigc_TpetraExport_print(farg1, farg2) & -bind(C, name="_wrap_TpetraExport_print") -use, intrinsic :: ISO_C_BINDING -import :: swigclasswrapper -type(SwigClassWrapper) :: farg1 -type(SwigClassWrapper) :: farg2 -end subroutine - subroutine swigc_TpetraExport_op_assign__(farg1, farg2) & bind(C, name="_wrap_TpetraExport_op_assign__") use, intrinsic :: ISO_C_BINDING @@ -1707,15 +1627,6 @@ subroutine swigc_TpetraMultiVector_dot__SWIG_0(farg1, farg2, farg3) & type(SwigArrayWrapper) :: farg3 end subroutine -subroutine swigc_TpetraMultiVector_dot__SWIG_3(farg1, farg2, farg3) & -bind(C, name="_wrap_TpetraMultiVector_dot__SWIG_3") -use, intrinsic :: ISO_C_BINDING -import :: swigclasswrapper -type(SwigClassWrapper) :: farg1 -type(SwigClassWrapper) :: farg2 -type(SwigClassWrapper) :: farg3 -end subroutine - subroutine swigc_TpetraMultiVector_abs(farg1, farg2) & bind(C, name="_wrap_TpetraMultiVector_abs") use, intrinsic :: ISO_C_BINDING @@ -1780,14 +1691,6 @@ subroutine swigc_TpetraMultiVector_update__SWIG_1(farg1, farg2, farg3, farg4, fa real(C_DOUBLE), intent(in) :: farg6 end subroutine -subroutine swigc_TpetraMultiVector_norm1__SWIG_1(farg1, farg2) & -bind(C, name="_wrap_TpetraMultiVector_norm1__SWIG_1") -use, intrinsic :: ISO_C_BINDING -import :: swigclasswrapper -type(SwigClassWrapper) :: farg1 -type(SwigClassWrapper) :: farg2 -end subroutine - subroutine swigc_TpetraMultiVector_norm1__SWIG_3(farg1, farg2) & bind(C, name="_wrap_TpetraMultiVector_norm1__SWIG_3") use, intrinsic :: ISO_C_BINDING @@ -1797,14 +1700,6 @@ subroutine swigc_TpetraMultiVector_norm1__SWIG_3(farg1, farg2) & type(SwigArrayWrapper) :: farg2 end subroutine -subroutine swigc_TpetraMultiVector_norm2__SWIG_1(farg1, farg2) & -bind(C, name="_wrap_TpetraMultiVector_norm2__SWIG_1") -use, intrinsic :: ISO_C_BINDING -import :: swigclasswrapper -type(SwigClassWrapper) :: farg1 -type(SwigClassWrapper) :: farg2 -end subroutine - subroutine swigc_TpetraMultiVector_norm2__SWIG_3(farg1, farg2) & bind(C, name="_wrap_TpetraMultiVector_norm2__SWIG_3") use, intrinsic :: ISO_C_BINDING @@ -1814,14 +1709,6 @@ subroutine swigc_TpetraMultiVector_norm2__SWIG_3(farg1, farg2) & type(SwigArrayWrapper) :: farg2 end subroutine -subroutine swigc_TpetraMultiVector_normInf__SWIG_1(farg1, farg2) & -bind(C, name="_wrap_TpetraMultiVector_normInf__SWIG_1") -use, intrinsic :: ISO_C_BINDING -import :: swigclasswrapper -type(SwigClassWrapper) :: farg1 -type(SwigClassWrapper) :: farg2 -end subroutine - subroutine swigc_TpetraMultiVector_normInf__SWIG_3(farg1, farg2) & bind(C, name="_wrap_TpetraMultiVector_normInf__SWIG_3") use, intrinsic :: ISO_C_BINDING @@ -3202,27 +3089,6 @@ function swigc_new_TpetraCrsMatrix__SWIG_13(farg1) & type(SwigClassWrapper) :: fresult end function -function swigc_new_TpetraCrsMatrix__SWIG_14(farg1, farg2, farg3) & -bind(C, name="_wrap_new_TpetraCrsMatrix__SWIG_14") & -result(fresult) -use, intrinsic :: ISO_C_BINDING -import :: swigclasswrapper -type(SwigClassWrapper) :: farg1 -type(SwigClassWrapper) :: farg2 -type(SwigClassWrapper) :: farg3 -type(SwigClassWrapper) :: fresult -end function - -function swigc_new_TpetraCrsMatrix__SWIG_15(farg1, farg2) & -bind(C, name="_wrap_new_TpetraCrsMatrix__SWIG_15") & -result(fresult) -use, intrinsic :: ISO_C_BINDING -import :: swigclasswrapper -type(SwigClassWrapper) :: farg1 -type(SwigClassWrapper) :: farg2 -type(SwigClassWrapper) :: fresult -end function - function swigc_new_TpetraCrsMatrix__SWIG_16(farg1, farg2, farg3, farg4, farg5, farg6) & bind(C, name="_wrap_new_TpetraCrsMatrix__SWIG_16") & result(fresult) @@ -3779,14 +3645,6 @@ subroutine swigc_TpetraCrsMatrix_getGlobalRowView(farg1, farg2, farg3, farg4) & type(SwigArrayWrapper) :: farg4 end subroutine -subroutine swigc_TpetraCrsMatrix_getLocalDiagOffsets(farg1, farg2) & -bind(C, name="_wrap_TpetraCrsMatrix_getLocalDiagOffsets") -use, intrinsic :: ISO_C_BINDING -import :: swigclasswrapper -type(SwigClassWrapper) :: farg1 -type(SwigClassWrapper) :: farg2 -end subroutine - subroutine swigc_TpetraCrsMatrix_apply__SWIG_0(farg1, farg2, farg3, farg4, farg5, farg6) & bind(C, name="_wrap_TpetraCrsMatrix_apply__SWIG_0") use, intrinsic :: ISO_C_BINDING @@ -4420,28 +4278,6 @@ function combineModeToString(combinemode) & call SWIG_free(fresult%data) end function -function swigf_new_TpetraMap__SWIG_0(numglobalelements, comm, lg, node) & -result(self) -use, intrinsic :: ISO_C_BINDING -type(TpetraMap) :: self -integer(C_LONG), intent(in) :: numglobalelements -class(TeuchosComm), intent(in) :: comm -integer(TpetraLocalGlobal), intent(in) :: lg -class(SWIGTYPE_p_Teuchos__RCPT_Kokkos__Compat__KokkosSerialWrappTF2SL), intent(in) :: node -type(SwigClassWrapper) :: fresult -integer(C_LONG) :: farg1 -type(SwigClassWrapper) :: farg3 -integer(C_INT) :: farg4 -type(SwigClassWrapper) :: farg5 - -farg1 = numglobalelements -farg3 = comm%swigdata -farg4 = lg -farg5 = node%swigdata -fresult = swigc_new_TpetraMap__SWIG_0(farg1, farg3, farg4, farg5) -self%swigdata = fresult -end function - function swigf_new_TpetraMap__SWIG_1(numglobalelements, comm, lg) & result(self) use, intrinsic :: ISO_C_BINDING @@ -4477,28 +4313,6 @@ function swigf_new_TpetraMap__SWIG_2(numglobalelements, comm) & self%swigdata = fresult end function -function swigf_new_TpetraMap__SWIG_3(numglobalelements, numlocalelements, comm, node) & -result(self) -use, intrinsic :: ISO_C_BINDING -type(TpetraMap) :: self -integer(C_LONG), intent(in) :: numglobalelements -integer, intent(in) :: numlocalelements -class(TeuchosComm), intent(in) :: comm -class(SWIGTYPE_p_Teuchos__RCPT_Kokkos__Compat__KokkosSerialWrappTF2SL), intent(in) :: node -type(SwigClassWrapper) :: fresult -integer(C_LONG) :: farg1 -integer(C_INT) :: farg2 -type(SwigClassWrapper) :: farg4 -type(SwigClassWrapper) :: farg5 - -farg1 = numglobalelements -farg2 = int(numlocalelements, C_INT) -farg4 = comm%swigdata -farg5 = node%swigdata -fresult = swigc_new_TpetraMap__SWIG_3(farg1, farg2, farg4, farg5) -self%swigdata = fresult -end function - function swigf_new_TpetraMap__SWIG_4(numglobalelements, numlocalelements, comm) & result(self) use, intrinsic :: ISO_C_BINDING @@ -4518,7 +4332,7 @@ function swigf_new_TpetraMap__SWIG_4(numglobalelements, numlocalelements, comm) self%swigdata = fresult end function -function swigf_new_TpetraMap__SWIG_5(numglobalelements, indexlist, comm, node) & +function swigf_new_TpetraMap__SWIG_7(numglobalelements, indexlist, comm) & result(self) use, intrinsic :: ISO_C_BINDING type(TpetraMap) :: self @@ -4526,12 +4340,10 @@ function swigf_new_TpetraMap__SWIG_5(numglobalelements, indexlist, comm, node) & integer(C_LONG_LONG), dimension(:), target :: indexlist integer(C_LONG_LONG), pointer :: farg2_view class(TeuchosComm), intent(in) :: comm -class(SWIGTYPE_p_Teuchos__RCPT_Kokkos__Compat__KokkosSerialWrappTF2SL), intent(in) :: node type(SwigClassWrapper) :: fresult integer(C_LONG) :: farg1 type(SwigArrayWrapper) :: farg2 type(SwigClassWrapper) :: farg4 -type(SwigClassWrapper) :: farg5 farg1 = numglobalelements if (size(indexlist) > 0) then @@ -4543,45 +4355,17 @@ function swigf_new_TpetraMap__SWIG_5(numglobalelements, indexlist, comm, node) & farg2%size = 0 end if farg4 = comm%swigdata -farg5 = node%swigdata -fresult = swigc_new_TpetraMap__SWIG_5(farg1, farg2, farg4, farg5) +fresult = swigc_new_TpetraMap__SWIG_7(farg1, farg2, farg4) self%swigdata = fresult end function -function swigf_new_TpetraMap__SWIG_6(numglobalelements, indexlist, comm) & +function swigf_new_TpetraMap__SWIG_8() & result(self) use, intrinsic :: ISO_C_BINDING type(TpetraMap) :: self -integer(C_LONG), intent(in) :: numglobalelements -integer(C_LONG_LONG), dimension(:), target :: indexlist -integer(C_LONG_LONG), pointer :: farg2_view -class(TeuchosComm), intent(in) :: comm type(SwigClassWrapper) :: fresult -integer(C_LONG) :: farg1 -type(SwigArrayWrapper) :: farg2 -type(SwigClassWrapper) :: farg4 -farg1 = numglobalelements -if (size(indexlist) > 0) then -farg2_view => indexlist(1) -farg2%data = c_loc(farg2_view) -farg2%size = size(indexlist) -else -farg2%data = c_null_ptr -farg2%size = 0 -end if -farg4 = comm%swigdata -fresult = swigc_new_TpetraMap__SWIG_6(farg1, farg2, farg4) -self%swigdata = fresult -end function - -function swigf_new_TpetraMap__SWIG_7() & -result(self) -use, intrinsic :: ISO_C_BINDING -type(TpetraMap) :: self -type(SwigClassWrapper) :: fresult - -fresult = swigc_new_TpetraMap__SWIG_7() +fresult = swigc_new_TpetraMap__SWIG_8() self%swigdata = fresult end function @@ -5286,18 +5070,6 @@ function swigf_TpetraImport_createRemoteOnlyImport(self, remotetarget) & swig_result%swigdata = fresult end function -subroutine swigf_TpetraImport_print(self, os) -use, intrinsic :: ISO_C_BINDING -class(TpetraImport), intent(in) :: self -class(SWIGTYPE_p_std__ostream), intent(in) :: os -type(SwigClassWrapper) :: farg1 -type(SwigClassWrapper) :: farg2 - -farg1 = self%swigdata -farg2 = os%swigdata -call swigc_TpetraImport_print(farg1, farg2) -end subroutine - subroutine swigf_TpetraImport_op_assign__(self, other) use, intrinsic :: ISO_C_BINDING class(TpetraImport), intent(inout) :: self @@ -5489,18 +5261,6 @@ function swigf_TpetraExport_isLocallyComplete(self) & swig_result = SWIG_int_to_logical(fresult) end function -subroutine swigf_TpetraExport_print(self, os) -use, intrinsic :: ISO_C_BINDING -class(TpetraExport), intent(in) :: self -class(SWIGTYPE_p_std__ostream), intent(in) :: os -type(SwigClassWrapper) :: farg1 -type(SwigClassWrapper) :: farg2 - -farg1 = self%swigdata -farg2 = os%swigdata -call swigc_TpetraExport_print(farg1, farg2) -end subroutine - subroutine swigf_TpetraExport_op_assign__(self, other) use, intrinsic :: ISO_C_BINDING class(TpetraExport), intent(inout) :: self @@ -6155,21 +5915,6 @@ subroutine swigf_TpetraMultiVector_dot__SWIG_0(self, a, dots) call swigc_TpetraMultiVector_dot__SWIG_0(farg1, farg2, farg3) end subroutine -subroutine swigf_TpetraMultiVector_dot__SWIG_3(self, a, norms) -use, intrinsic :: ISO_C_BINDING -class(TpetraMultiVector), intent(in) :: self -class(TpetraMultiVector), intent(in) :: a -class(SWIGTYPE_p_Kokkos__ViewT_double_p_Kokkos__HostSpace_t), intent(in) :: norms -type(SwigClassWrapper) :: farg1 -type(SwigClassWrapper) :: farg2 -type(SwigClassWrapper) :: farg3 - -farg1 = self%swigdata -farg2 = a%swigdata -farg3 = norms%swigdata -call swigc_TpetraMultiVector_dot__SWIG_3(farg1, farg2, farg3) -end subroutine - subroutine swigf_TpetraMultiVector_abs(self, a) use, intrinsic :: ISO_C_BINDING class(TpetraMultiVector), intent(in) :: self @@ -6283,18 +6028,6 @@ subroutine swigf_TpetraMultiVector_update__SWIG_1(self, alpha, a, beta, b, gamma call swigc_TpetraMultiVector_update__SWIG_1(farg1, farg2, farg3, farg4, farg5, farg6) end subroutine -subroutine swigf_TpetraMultiVector_norm1__SWIG_1(self, norms) -use, intrinsic :: ISO_C_BINDING -class(TpetraMultiVector), intent(in) :: self -class(SWIGTYPE_p_Kokkos__ViewT_double_p_Kokkos__HostSpace_t), intent(in) :: norms -type(SwigClassWrapper) :: farg1 -type(SwigClassWrapper) :: farg2 - -farg1 = self%swigdata -farg2 = norms%swigdata -call swigc_TpetraMultiVector_norm1__SWIG_1(farg1, farg2) -end subroutine - subroutine swigf_TpetraMultiVector_norm1__SWIG_3(self, norms) use, intrinsic :: ISO_C_BINDING class(TpetraMultiVector), intent(in) :: self @@ -6315,18 +6048,6 @@ subroutine swigf_TpetraMultiVector_norm1__SWIG_3(self, norms) call swigc_TpetraMultiVector_norm1__SWIG_3(farg1, farg2) end subroutine -subroutine swigf_TpetraMultiVector_norm2__SWIG_1(self, norms) -use, intrinsic :: ISO_C_BINDING -class(TpetraMultiVector), intent(in) :: self -class(SWIGTYPE_p_Kokkos__ViewT_double_p_Kokkos__HostSpace_t), intent(in) :: norms -type(SwigClassWrapper) :: farg1 -type(SwigClassWrapper) :: farg2 - -farg1 = self%swigdata -farg2 = norms%swigdata -call swigc_TpetraMultiVector_norm2__SWIG_1(farg1, farg2) -end subroutine - subroutine swigf_TpetraMultiVector_norm2__SWIG_3(self, norms) use, intrinsic :: ISO_C_BINDING class(TpetraMultiVector), intent(in) :: self @@ -6347,18 +6068,6 @@ subroutine swigf_TpetraMultiVector_norm2__SWIG_3(self, norms) call swigc_TpetraMultiVector_norm2__SWIG_3(farg1, farg2) end subroutine -subroutine swigf_TpetraMultiVector_normInf__SWIG_1(self, norms) -use, intrinsic :: ISO_C_BINDING -class(TpetraMultiVector), intent(in) :: self -class(SWIGTYPE_p_Kokkos__ViewT_double_p_Kokkos__HostSpace_t), intent(in) :: norms -type(SwigClassWrapper) :: farg1 -type(SwigClassWrapper) :: farg2 - -farg1 = self%swigdata -farg2 = norms%swigdata -call swigc_TpetraMultiVector_normInf__SWIG_1(farg1, farg2) -end subroutine - subroutine swigf_TpetraMultiVector_normInf__SWIG_3(self, norms) use, intrinsic :: ISO_C_BINDING class(TpetraMultiVector), intent(in) :: self @@ -8904,41 +8613,6 @@ function swigf_new_TpetraCrsMatrix__SWIG_13(graph) & self%swigdata = fresult end function -function swigf_new_TpetraCrsMatrix__SWIG_14(graph, values, params) & -result(self) -use, intrinsic :: ISO_C_BINDING -type(TpetraCrsMatrix) :: self -class(TpetraCrsGraph), intent(in) :: graph -class(SWIGTYPE_p_KokkosSparse__CrsMatrixT_Tpetra__CrsMatrixT_douC8X8I), intent(in) :: values -class(ParameterList), intent(in) :: params -type(SwigClassWrapper) :: fresult -type(SwigClassWrapper) :: farg1 -type(SwigClassWrapper) :: farg2 -type(SwigClassWrapper) :: farg3 - -farg1 = graph%swigdata -farg2 = values%swigdata -farg3 = params%swigdata -fresult = swigc_new_TpetraCrsMatrix__SWIG_14(farg1, farg2, farg3) -self%swigdata = fresult -end function - -function swigf_new_TpetraCrsMatrix__SWIG_15(graph, values) & -result(self) -use, intrinsic :: ISO_C_BINDING -type(TpetraCrsMatrix) :: self -class(TpetraCrsGraph), intent(in) :: graph -class(SWIGTYPE_p_KokkosSparse__CrsMatrixT_Tpetra__CrsMatrixT_douC8X8I), intent(in) :: values -type(SwigClassWrapper) :: fresult -type(SwigClassWrapper) :: farg1 -type(SwigClassWrapper) :: farg2 - -farg1 = graph%swigdata -farg2 = values%swigdata -fresult = swigc_new_TpetraCrsMatrix__SWIG_15(farg1, farg2) -self%swigdata = fresult -end function - function swigf_new_TpetraCrsMatrix__SWIG_16(rowmap, colmap, rowpointers, columnindices, values, params) & result(self) use, intrinsic :: ISO_C_BINDING @@ -10052,18 +9726,6 @@ subroutine swigf_TpetraCrsMatrix_getGlobalRowView(self, globalrow, indices, valu endif end subroutine -subroutine swigf_TpetraCrsMatrix_getLocalDiagOffsets(self, offsets) -use, intrinsic :: ISO_C_BINDING -class(TpetraCrsMatrix), intent(in) :: self -class(SWIGTYPE_p_Teuchos__ArrayRCPT_unsigned_long_t), intent(in) :: offsets -type(SwigClassWrapper) :: farg1 -type(SwigClassWrapper) :: farg2 - -farg1 = self%swigdata -farg2 = offsets%swigdata -call swigc_TpetraCrsMatrix_getLocalDiagOffsets(farg1, farg2) -end subroutine - subroutine swigf_TpetraCrsMatrix_apply__SWIG_0(self, x, y, mode, alpha, beta) use, intrinsic :: ISO_C_BINDING class(TpetraCrsMatrix), intent(in) :: self diff --git a/src/tpetra/src/swig/fortpetraFORTRAN_wrap.cxx b/src/tpetra/src/swig/fortpetraFORTRAN_wrap.cxx index c8632b04..ef367ced 100644 --- a/src/tpetra/src/swig/fortpetraFORTRAN_wrap.cxx +++ b/src/tpetra/src/swig/fortpetraFORTRAN_wrap.cxx @@ -731,53 +731,6 @@ SWIGEXPORT SwigArrayWrapper _wrap_combineModeToString(int const *farg1) { } -SWIGEXPORT SwigClassWrapper _wrap_new_TpetraMap__SWIG_0(long const *farg1, SwigClassWrapper const *farg3, int const *farg4, SwigClassWrapper const *farg5) { - SwigClassWrapper fresult ; - Tpetra::global_size_t arg1 ; - long long arg2 ; - Teuchos::RCP< Teuchos::Comm< int > const > *arg3 = 0 ; - Tpetra::LocalGlobal arg4 ; - Teuchos::RCP< Kokkos::Compat::KokkosSerialWrapperNode > *arg5 = 0 ; - Teuchos::RCP< Teuchos::Comm< int > const > tempnull3 ; - Tpetra::Map< LO,GO,NO > *result = 0 ; - - { - arg2 = 1; - } - arg1 = static_cast< Tpetra::global_size_t >(*farg1); - arg3 = farg3->cptr ? static_cast< Teuchos::RCP< Teuchos::Comm< int > const > * >(farg3->cptr) : &tempnull3; - arg4 = static_cast< Tpetra::LocalGlobal >(*farg4); - SWIG_check_nonnull(*farg5, "Teuchos::RCP< Kokkos::Compat::KokkosSerialWrapperNode > const &", "SWIGTYPE_p_Teuchos__RCPT_Kokkos__Compat__KokkosSerialWrappTF2SL", "Tpetra::Map< LO,GO,NO >::Map(Tpetra::global_size_t,long long,Teuchos::RCP< Teuchos::Comm< int > const > const &,Tpetra::LocalGlobal,Teuchos::RCP< Kokkos::Compat::KokkosSerialWrapperNode > const &)", return SwigClassWrapper_uninitialized()); - arg5 = static_cast< Teuchos::RCP< Kokkos::Compat::KokkosSerialWrapperNode > * >(farg5->cptr); - { - // Make sure no unhandled exceptions exist before performing a new action - SWIG_check_unhandled_exception_impl("Tpetra::Map< LO,GO,NO >::Map(Tpetra::global_size_t,long long,Teuchos::RCP< Teuchos::Comm< int > const > const &,Tpetra::LocalGlobal,Teuchos::RCP< Kokkos::Compat::KokkosSerialWrapperNode > const &)");; - try - { - // Attempt the wrapped function call - result = (Tpetra::Map< LO,GO,NO > *)new Tpetra::Map< LO,GO,NO >(arg1,arg2,(Teuchos::RCP< Teuchos::Comm< int > const > const &)*arg3,arg4,(Teuchos::RCP< Kokkos::Compat::KokkosSerialWrapperNode > const &)*arg5); - } - catch (const std::range_error& e) - { - // Store a C++ exception - SWIG_exception_impl("Tpetra::Map< LO,GO,NO >::Map(Tpetra::global_size_t,long long,Teuchos::RCP< Teuchos::Comm< int > const > const &,Tpetra::LocalGlobal,Teuchos::RCP< Kokkos::Compat::KokkosSerialWrapperNode > const &)", SWIG_IndexError, e.what(), return SwigClassWrapper_uninitialized()); - } - catch (const std::exception& e) - { - // Store a C++ exception - SWIG_exception_impl("Tpetra::Map< LO,GO,NO >::Map(Tpetra::global_size_t,long long,Teuchos::RCP< Teuchos::Comm< int > const > const &,Tpetra::LocalGlobal,Teuchos::RCP< Kokkos::Compat::KokkosSerialWrapperNode > const &)", SWIG_RuntimeError, e.what(), return SwigClassWrapper_uninitialized()); - } - catch (...) - { - SWIG_exception_impl("Tpetra::Map< LO,GO,NO >::Map(Tpetra::global_size_t,long long,Teuchos::RCP< Teuchos::Comm< int > const > const &,Tpetra::LocalGlobal,Teuchos::RCP< Kokkos::Compat::KokkosSerialWrapperNode > const &)", SWIG_UnknownError, "An unknown exception occurred", return SwigClassWrapper_uninitialized()); - } - } - fresult.cptr = result ? new Teuchos::RCP< Tpetra::Map >(result SWIG_NO_NULL_DELETER_1) : NULL; - fresult.cmemflags = SWIG_MEM_OWN | SWIG_MEM_RVALUE | SWIG_sp_mem_flags; - return fresult; -} - - SWIGEXPORT SwigClassWrapper _wrap_new_TpetraMap__SWIG_1(long const *farg1, SwigClassWrapper const *farg3, int const *farg4) { SwigClassWrapper fresult ; Tpetra::global_size_t arg1 ; @@ -864,53 +817,6 @@ SWIGEXPORT SwigClassWrapper _wrap_new_TpetraMap__SWIG_2(long const *farg1, SwigC } -SWIGEXPORT SwigClassWrapper _wrap_new_TpetraMap__SWIG_3(long const *farg1, int const *farg2, SwigClassWrapper const *farg4, SwigClassWrapper const *farg5) { - SwigClassWrapper fresult ; - Tpetra::global_size_t arg1 ; - size_t arg2 ; - long long arg3 ; - Teuchos::RCP< Teuchos::Comm< int > const > *arg4 = 0 ; - Teuchos::RCP< Kokkos::Compat::KokkosSerialWrapperNode > *arg5 = 0 ; - Teuchos::RCP< Teuchos::Comm< int > const > tempnull4 ; - Tpetra::Map< LO,GO,NO > *result = 0 ; - - { - arg3 = 1; - } - arg1 = static_cast< Tpetra::global_size_t >(*farg1); - arg2 = static_cast< size_t >(*farg2); - arg4 = farg4->cptr ? static_cast< Teuchos::RCP< Teuchos::Comm< int > const > * >(farg4->cptr) : &tempnull4; - SWIG_check_nonnull(*farg5, "Teuchos::RCP< Kokkos::Compat::KokkosSerialWrapperNode > const &", "SWIGTYPE_p_Teuchos__RCPT_Kokkos__Compat__KokkosSerialWrappTF2SL", "Tpetra::Map< LO,GO,NO >::Map(Tpetra::global_size_t,size_t,long long,Teuchos::RCP< Teuchos::Comm< int > const > const &,Teuchos::RCP< Kokkos::Compat::KokkosSerialWrapperNode > const &)", return SwigClassWrapper_uninitialized()); - arg5 = static_cast< Teuchos::RCP< Kokkos::Compat::KokkosSerialWrapperNode > * >(farg5->cptr); - { - // Make sure no unhandled exceptions exist before performing a new action - SWIG_check_unhandled_exception_impl("Tpetra::Map< LO,GO,NO >::Map(Tpetra::global_size_t,size_t,long long,Teuchos::RCP< Teuchos::Comm< int > const > const &,Teuchos::RCP< Kokkos::Compat::KokkosSerialWrapperNode > const &)");; - try - { - // Attempt the wrapped function call - result = (Tpetra::Map< LO,GO,NO > *)new Tpetra::Map< LO,GO,NO >(arg1,arg2,arg3,(Teuchos::RCP< Teuchos::Comm< int > const > const &)*arg4,(Teuchos::RCP< Kokkos::Compat::KokkosSerialWrapperNode > const &)*arg5); - } - catch (const std::range_error& e) - { - // Store a C++ exception - SWIG_exception_impl("Tpetra::Map< LO,GO,NO >::Map(Tpetra::global_size_t,size_t,long long,Teuchos::RCP< Teuchos::Comm< int > const > const &,Teuchos::RCP< Kokkos::Compat::KokkosSerialWrapperNode > const &)", SWIG_IndexError, e.what(), return SwigClassWrapper_uninitialized()); - } - catch (const std::exception& e) - { - // Store a C++ exception - SWIG_exception_impl("Tpetra::Map< LO,GO,NO >::Map(Tpetra::global_size_t,size_t,long long,Teuchos::RCP< Teuchos::Comm< int > const > const &,Teuchos::RCP< Kokkos::Compat::KokkosSerialWrapperNode > const &)", SWIG_RuntimeError, e.what(), return SwigClassWrapper_uninitialized()); - } - catch (...) - { - SWIG_exception_impl("Tpetra::Map< LO,GO,NO >::Map(Tpetra::global_size_t,size_t,long long,Teuchos::RCP< Teuchos::Comm< int > const > const &,Teuchos::RCP< Kokkos::Compat::KokkosSerialWrapperNode > const &)", SWIG_UnknownError, "An unknown exception occurred", return SwigClassWrapper_uninitialized()); - } - } - fresult.cptr = result ? new Teuchos::RCP< Tpetra::Map >(result SWIG_NO_NULL_DELETER_1) : NULL; - fresult.cmemflags = SWIG_MEM_OWN | SWIG_MEM_RVALUE | SWIG_sp_mem_flags; - return fresult; -} - - SWIGEXPORT SwigClassWrapper _wrap_new_TpetraMap__SWIG_4(long const *farg1, int const *farg2, SwigClassWrapper const *farg4) { SwigClassWrapper fresult ; Tpetra::global_size_t arg1 ; @@ -955,56 +861,7 @@ SWIGEXPORT SwigClassWrapper _wrap_new_TpetraMap__SWIG_4(long const *farg1, int c } -SWIGEXPORT SwigClassWrapper _wrap_new_TpetraMap__SWIG_5(long const *farg1, SwigArrayWrapper *farg2, SwigClassWrapper const *farg4, SwigClassWrapper const *farg5) { - SwigClassWrapper fresult ; - Tpetra::global_size_t arg1 ; - Teuchos::ArrayView< long long const > *arg2 = 0 ; - long long arg3 ; - Teuchos::RCP< Teuchos::Comm< int > const > *arg4 = 0 ; - Teuchos::RCP< Kokkos::Compat::KokkosSerialWrapperNode > *arg5 = 0 ; - Teuchos::ArrayView< long long const > tmpview2 ; - Teuchos::RCP< Teuchos::Comm< int > const > tempnull4 ; - Tpetra::Map< LO,GO,NO > *result = 0 ; - - { - arg3 = 1; - } - arg1 = static_cast< Tpetra::global_size_t >(*farg1); - tmpview2 = Teuchos::ArrayView(static_cast(farg2->data), farg2->size); - arg2 = &tmpview2; - arg4 = farg4->cptr ? static_cast< Teuchos::RCP< Teuchos::Comm< int > const > * >(farg4->cptr) : &tempnull4; - SWIG_check_nonnull(*farg5, "Teuchos::RCP< Kokkos::Compat::KokkosSerialWrapperNode > const &", "SWIGTYPE_p_Teuchos__RCPT_Kokkos__Compat__KokkosSerialWrappTF2SL", "Tpetra::Map< LO,GO,NO >::Map(Tpetra::global_size_t const,Teuchos::ArrayView< long long const > const &,long long const,Teuchos::RCP< Teuchos::Comm< int > const > const &,Teuchos::RCP< Kokkos::Compat::KokkosSerialWrapperNode > const &)", return SwigClassWrapper_uninitialized()); - arg5 = static_cast< Teuchos::RCP< Kokkos::Compat::KokkosSerialWrapperNode > * >(farg5->cptr); - { - // Make sure no unhandled exceptions exist before performing a new action - SWIG_check_unhandled_exception_impl("Tpetra::Map< LO,GO,NO >::Map(Tpetra::global_size_t const,Teuchos::ArrayView< long long const > const &,long long const,Teuchos::RCP< Teuchos::Comm< int > const > const &,Teuchos::RCP< Kokkos::Compat::KokkosSerialWrapperNode > const &)");; - try - { - // Attempt the wrapped function call - result = (Tpetra::Map< LO,GO,NO > *)new Tpetra::Map< LO,GO,NO >(arg1,(Teuchos::ArrayView< long long const > const &)*arg2,arg3,(Teuchos::RCP< Teuchos::Comm< int > const > const &)*arg4,(Teuchos::RCP< Kokkos::Compat::KokkosSerialWrapperNode > const &)*arg5); - } - catch (const std::range_error& e) - { - // Store a C++ exception - SWIG_exception_impl("Tpetra::Map< LO,GO,NO >::Map(Tpetra::global_size_t const,Teuchos::ArrayView< long long const > const &,long long const,Teuchos::RCP< Teuchos::Comm< int > const > const &,Teuchos::RCP< Kokkos::Compat::KokkosSerialWrapperNode > const &)", SWIG_IndexError, e.what(), return SwigClassWrapper_uninitialized()); - } - catch (const std::exception& e) - { - // Store a C++ exception - SWIG_exception_impl("Tpetra::Map< LO,GO,NO >::Map(Tpetra::global_size_t const,Teuchos::ArrayView< long long const > const &,long long const,Teuchos::RCP< Teuchos::Comm< int > const > const &,Teuchos::RCP< Kokkos::Compat::KokkosSerialWrapperNode > const &)", SWIG_RuntimeError, e.what(), return SwigClassWrapper_uninitialized()); - } - catch (...) - { - SWIG_exception_impl("Tpetra::Map< LO,GO,NO >::Map(Tpetra::global_size_t const,Teuchos::ArrayView< long long const > const &,long long const,Teuchos::RCP< Teuchos::Comm< int > const > const &,Teuchos::RCP< Kokkos::Compat::KokkosSerialWrapperNode > const &)", SWIG_UnknownError, "An unknown exception occurred", return SwigClassWrapper_uninitialized()); - } - } - fresult.cptr = result ? new Teuchos::RCP< Tpetra::Map >(result SWIG_NO_NULL_DELETER_1) : NULL; - fresult.cmemflags = SWIG_MEM_OWN | SWIG_MEM_RVALUE | SWIG_sp_mem_flags; - return fresult; -} - - -SWIGEXPORT SwigClassWrapper _wrap_new_TpetraMap__SWIG_6(long const *farg1, SwigArrayWrapper *farg2, SwigClassWrapper const *farg4) { +SWIGEXPORT SwigClassWrapper _wrap_new_TpetraMap__SWIG_7(long const *farg1, SwigArrayWrapper *farg2, SwigClassWrapper const *farg4) { SwigClassWrapper fresult ; Tpetra::global_size_t arg1 ; Teuchos::ArrayView< long long const > *arg2 = 0 ; @@ -1050,7 +907,7 @@ SWIGEXPORT SwigClassWrapper _wrap_new_TpetraMap__SWIG_6(long const *farg1, SwigA } -SWIGEXPORT SwigClassWrapper _wrap_new_TpetraMap__SWIG_7() { +SWIGEXPORT SwigClassWrapper _wrap_new_TpetraMap__SWIG_8() { SwigClassWrapper fresult ; Tpetra::Map< LO,GO,NO > *result = 0 ; @@ -2767,41 +2624,6 @@ SWIGEXPORT SwigClassWrapper _wrap_TpetraImport_createRemoteOnlyImport(SwigClassW } -SWIGEXPORT void _wrap_TpetraImport_print(SwigClassWrapper const *farg1, SwigClassWrapper const *farg2) { - Tpetra::Import< LO,GO,NO > *arg1 = (Tpetra::Import< LO,GO,NO > *) 0 ; - std::ostream *arg2 = 0 ; - Teuchos::RCP< Tpetra::Import< LO,GO,NO > const > *smartarg1 ; - - smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); - arg1 = smartarg1 ? const_cast< Tpetra::Import* >(smartarg1->get()) : NULL; - SWIG_check_mutable_nonnull(*farg2, "std::ostream &", "SWIGTYPE_p_std__ostream", "Tpetra::Import< LO,GO,NO >::print(std::ostream &) const", return ); - arg2 = static_cast< std::ostream * >(farg2->cptr); - { - // Make sure no unhandled exceptions exist before performing a new action - SWIG_check_unhandled_exception_impl("Tpetra::Import< LO,GO,NO >::print(std::ostream &) const");; - try - { - // Attempt the wrapped function call - ((Tpetra::Import< LO,GO,NO > const *)arg1)->print(*arg2); - } - catch (const std::range_error& e) - { - // Store a C++ exception - SWIG_exception_impl("Tpetra::Import< LO,GO,NO >::print(std::ostream &) const", SWIG_IndexError, e.what(), return ); - } - catch (const std::exception& e) - { - // Store a C++ exception - SWIG_exception_impl("Tpetra::Import< LO,GO,NO >::print(std::ostream &) const", SWIG_RuntimeError, e.what(), return ); - } - catch (...) - { - SWIG_exception_impl("Tpetra::Import< LO,GO,NO >::print(std::ostream &) const", SWIG_UnknownError, "An unknown exception occurred", return ); - } - } -} - - SWIGEXPORT void _wrap_TpetraImport_op_assign__(SwigClassWrapper *farg1, SwigClassWrapper const *farg2) { Tpetra::Import< LO,GO,NO > *arg1 = (Tpetra::Import< LO,GO,NO > *) 0 ; Tpetra::Import< LO,GO,NO > *arg2 = 0 ; @@ -3296,41 +3118,6 @@ SWIGEXPORT int _wrap_TpetraExport_isLocallyComplete(SwigClassWrapper const *farg } -SWIGEXPORT void _wrap_TpetraExport_print(SwigClassWrapper const *farg1, SwigClassWrapper const *farg2) { - Tpetra::Export< LO,GO,NO > *arg1 = (Tpetra::Export< LO,GO,NO > *) 0 ; - std::ostream *arg2 = 0 ; - Teuchos::RCP< Tpetra::Export< LO,GO,NO > const > *smartarg1 ; - - smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); - arg1 = smartarg1 ? const_cast< Tpetra::Export* >(smartarg1->get()) : NULL; - SWIG_check_mutable_nonnull(*farg2, "std::ostream &", "SWIGTYPE_p_std__ostream", "Tpetra::Export< LO,GO,NO >::print(std::ostream &) const", return ); - arg2 = static_cast< std::ostream * >(farg2->cptr); - { - // Make sure no unhandled exceptions exist before performing a new action - SWIG_check_unhandled_exception_impl("Tpetra::Export< LO,GO,NO >::print(std::ostream &) const");; - try - { - // Attempt the wrapped function call - ((Tpetra::Export< LO,GO,NO > const *)arg1)->print(*arg2); - } - catch (const std::range_error& e) - { - // Store a C++ exception - SWIG_exception_impl("Tpetra::Export< LO,GO,NO >::print(std::ostream &) const", SWIG_IndexError, e.what(), return ); - } - catch (const std::exception& e) - { - // Store a C++ exception - SWIG_exception_impl("Tpetra::Export< LO,GO,NO >::print(std::ostream &) const", SWIG_RuntimeError, e.what(), return ); - } - catch (...) - { - SWIG_exception_impl("Tpetra::Export< LO,GO,NO >::print(std::ostream &) const", SWIG_UnknownError, "An unknown exception occurred", return ); - } - } -} - - SWIGEXPORT void _wrap_TpetraExport_op_assign__(SwigClassWrapper *farg1, SwigClassWrapper const *farg2) { Tpetra::Export< LO,GO,NO > *arg1 = (Tpetra::Export< LO,GO,NO > *) 0 ; Tpetra::Export< LO,GO,NO > *arg2 = 0 ; @@ -4812,46 +4599,6 @@ SWIGEXPORT void _wrap_TpetraMultiVector_dot__SWIG_0(SwigClassWrapper const *farg } -SWIGEXPORT void _wrap_TpetraMultiVector_dot__SWIG_3(SwigClassWrapper const *farg1, SwigClassWrapper const *farg2, SwigClassWrapper const *farg3) { - Tpetra::MultiVector< SC,LO,GO,NO > *arg1 = (Tpetra::MultiVector< SC,LO,GO,NO > *) 0 ; - Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > *arg2 = 0 ; - Kokkos::View< Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::dot_type *,Kokkos::HostSpace > *arg3 = 0 ; - Teuchos::RCP< Tpetra::MultiVector< SC,LO,GO,NO > const > *smartarg1 ; - Teuchos::RCP< Tpetra::MultiVector< SC,LO,GO,NO > const > *smartarg2 ; - - smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); - arg1 = smartarg1 ? const_cast< Tpetra::MultiVector* >(smartarg1->get()) : NULL; - SWIG_check_sp_nonnull(farg2, "Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > *", "TpetraMultiVector", "Tpetra::MultiVector< SC,LO,GO,NO >::dot(Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &,Kokkos::View< Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::dot_type *,Kokkos::HostSpace > const &) const", return ) - smartarg2 = static_cast< Teuchos::RCP >* >(farg2->cptr); - arg2 = const_cast< Tpetra::MultiVector* >(smartarg2->get()); - SWIG_check_nonnull(*farg3, "Kokkos::View< Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::dot_type *,Kokkos::HostSpace > const &", "SWIGTYPE_p_Kokkos__ViewT_double_p_Kokkos__HostSpace_t", "Tpetra::MultiVector< SC,LO,GO,NO >::dot(Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &,Kokkos::View< Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::dot_type *,Kokkos::HostSpace > const &) const", return ); - arg3 = static_cast< Kokkos::View< Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::dot_type *,Kokkos::HostSpace > * >(farg3->cptr); - { - // Make sure no unhandled exceptions exist before performing a new action - SWIG_check_unhandled_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::dot(Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &,Kokkos::View< Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::dot_type *,Kokkos::HostSpace > const &) const");; - try - { - // Attempt the wrapped function call - ((Tpetra::MultiVector< SC,LO,GO,NO > const *)arg1)->dot((Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &)*arg2,(Kokkos::View< Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::dot_type *,Kokkos::HostSpace > const &)*arg3); - } - catch (const std::range_error& e) - { - // Store a C++ exception - SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::dot(Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &,Kokkos::View< Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::dot_type *,Kokkos::HostSpace > const &) const", SWIG_IndexError, e.what(), return ); - } - catch (const std::exception& e) - { - // Store a C++ exception - SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::dot(Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &,Kokkos::View< Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::dot_type *,Kokkos::HostSpace > const &) const", SWIG_RuntimeError, e.what(), return ); - } - catch (...) - { - SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::dot(Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > const &,Kokkos::View< Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::dot_type *,Kokkos::HostSpace > const &) const", SWIG_UnknownError, "An unknown exception occurred", return ); - } - } -} - - SWIGEXPORT void _wrap_TpetraMultiVector_abs(SwigClassWrapper const *farg1, SwigClassWrapper const *farg2) { Tpetra::MultiVector< SC,LO,GO,NO > *arg1 = (Tpetra::MultiVector< SC,LO,GO,NO > *) 0 ; Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > *arg2 = 0 ; @@ -5138,41 +4885,6 @@ SWIGEXPORT void _wrap_TpetraMultiVector_update__SWIG_1(SwigClassWrapper const *f } -SWIGEXPORT void _wrap_TpetraMultiVector_norm1__SWIG_1(SwigClassWrapper const *farg1, SwigClassWrapper const *farg2) { - Tpetra::MultiVector< SC,LO,GO,NO > *arg1 = (Tpetra::MultiVector< SC,LO,GO,NO > *) 0 ; - Kokkos::View< Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::mag_type *,Kokkos::HostSpace > *arg2 = 0 ; - Teuchos::RCP< Tpetra::MultiVector< SC,LO,GO,NO > const > *smartarg1 ; - - smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); - arg1 = smartarg1 ? const_cast< Tpetra::MultiVector* >(smartarg1->get()) : NULL; - SWIG_check_nonnull(*farg2, "Kokkos::View< Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::mag_type *,Kokkos::HostSpace > const &", "SWIGTYPE_p_Kokkos__ViewT_double_p_Kokkos__HostSpace_t", "Tpetra::MultiVector< SC,LO,GO,NO >::norm1(Kokkos::View< Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::mag_type *,Kokkos::HostSpace > const &) const", return ); - arg2 = static_cast< Kokkos::View< Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::mag_type *,Kokkos::HostSpace > * >(farg2->cptr); - { - // Make sure no unhandled exceptions exist before performing a new action - SWIG_check_unhandled_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::norm1(Kokkos::View< Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::mag_type *,Kokkos::HostSpace > const &) const");; - try - { - // Attempt the wrapped function call - ((Tpetra::MultiVector< SC,LO,GO,NO > const *)arg1)->norm1((Kokkos::View< Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::mag_type *,Kokkos::HostSpace > const &)*arg2); - } - catch (const std::range_error& e) - { - // Store a C++ exception - SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::norm1(Kokkos::View< Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::mag_type *,Kokkos::HostSpace > const &) const", SWIG_IndexError, e.what(), return ); - } - catch (const std::exception& e) - { - // Store a C++ exception - SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::norm1(Kokkos::View< Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::mag_type *,Kokkos::HostSpace > const &) const", SWIG_RuntimeError, e.what(), return ); - } - catch (...) - { - SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::norm1(Kokkos::View< Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::mag_type *,Kokkos::HostSpace > const &) const", SWIG_UnknownError, "An unknown exception occurred", return ); - } - } -} - - SWIGEXPORT void _wrap_TpetraMultiVector_norm1__SWIG_3(SwigClassWrapper const *farg1, SwigArrayWrapper *farg2) { Tpetra::MultiVector< SC,LO,GO,NO > *arg1 = (Tpetra::MultiVector< SC,LO,GO,NO > *) 0 ; Teuchos::ArrayView< Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::mag_type > *arg2 = 0 ; @@ -5209,41 +4921,6 @@ SWIGEXPORT void _wrap_TpetraMultiVector_norm1__SWIG_3(SwigClassWrapper const *fa } -SWIGEXPORT void _wrap_TpetraMultiVector_norm2__SWIG_1(SwigClassWrapper const *farg1, SwigClassWrapper const *farg2) { - Tpetra::MultiVector< SC,LO,GO,NO > *arg1 = (Tpetra::MultiVector< SC,LO,GO,NO > *) 0 ; - Kokkos::View< Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::mag_type *,Kokkos::HostSpace > *arg2 = 0 ; - Teuchos::RCP< Tpetra::MultiVector< SC,LO,GO,NO > const > *smartarg1 ; - - smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); - arg1 = smartarg1 ? const_cast< Tpetra::MultiVector* >(smartarg1->get()) : NULL; - SWIG_check_nonnull(*farg2, "Kokkos::View< Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::mag_type *,Kokkos::HostSpace > const &", "SWIGTYPE_p_Kokkos__ViewT_double_p_Kokkos__HostSpace_t", "Tpetra::MultiVector< SC,LO,GO,NO >::norm2(Kokkos::View< Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::mag_type *,Kokkos::HostSpace > const &) const", return ); - arg2 = static_cast< Kokkos::View< Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::mag_type *,Kokkos::HostSpace > * >(farg2->cptr); - { - // Make sure no unhandled exceptions exist before performing a new action - SWIG_check_unhandled_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::norm2(Kokkos::View< Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::mag_type *,Kokkos::HostSpace > const &) const");; - try - { - // Attempt the wrapped function call - ((Tpetra::MultiVector< SC,LO,GO,NO > const *)arg1)->norm2((Kokkos::View< Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::mag_type *,Kokkos::HostSpace > const &)*arg2); - } - catch (const std::range_error& e) - { - // Store a C++ exception - SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::norm2(Kokkos::View< Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::mag_type *,Kokkos::HostSpace > const &) const", SWIG_IndexError, e.what(), return ); - } - catch (const std::exception& e) - { - // Store a C++ exception - SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::norm2(Kokkos::View< Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::mag_type *,Kokkos::HostSpace > const &) const", SWIG_RuntimeError, e.what(), return ); - } - catch (...) - { - SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::norm2(Kokkos::View< Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::mag_type *,Kokkos::HostSpace > const &) const", SWIG_UnknownError, "An unknown exception occurred", return ); - } - } -} - - SWIGEXPORT void _wrap_TpetraMultiVector_norm2__SWIG_3(SwigClassWrapper const *farg1, SwigArrayWrapper *farg2) { Tpetra::MultiVector< SC,LO,GO,NO > *arg1 = (Tpetra::MultiVector< SC,LO,GO,NO > *) 0 ; Teuchos::ArrayView< Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::mag_type > *arg2 = 0 ; @@ -5280,41 +4957,6 @@ SWIGEXPORT void _wrap_TpetraMultiVector_norm2__SWIG_3(SwigClassWrapper const *fa } -SWIGEXPORT void _wrap_TpetraMultiVector_normInf__SWIG_1(SwigClassWrapper const *farg1, SwigClassWrapper const *farg2) { - Tpetra::MultiVector< SC,LO,GO,NO > *arg1 = (Tpetra::MultiVector< SC,LO,GO,NO > *) 0 ; - Kokkos::View< Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::mag_type *,Kokkos::HostSpace > *arg2 = 0 ; - Teuchos::RCP< Tpetra::MultiVector< SC,LO,GO,NO > const > *smartarg1 ; - - smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); - arg1 = smartarg1 ? const_cast< Tpetra::MultiVector* >(smartarg1->get()) : NULL; - SWIG_check_nonnull(*farg2, "Kokkos::View< Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::mag_type *,Kokkos::HostSpace > const &", "SWIGTYPE_p_Kokkos__ViewT_double_p_Kokkos__HostSpace_t", "Tpetra::MultiVector< SC,LO,GO,NO >::normInf(Kokkos::View< Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::mag_type *,Kokkos::HostSpace > const &) const", return ); - arg2 = static_cast< Kokkos::View< Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::mag_type *,Kokkos::HostSpace > * >(farg2->cptr); - { - // Make sure no unhandled exceptions exist before performing a new action - SWIG_check_unhandled_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::normInf(Kokkos::View< Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::mag_type *,Kokkos::HostSpace > const &) const");; - try - { - // Attempt the wrapped function call - ((Tpetra::MultiVector< SC,LO,GO,NO > const *)arg1)->normInf((Kokkos::View< Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::mag_type *,Kokkos::HostSpace > const &)*arg2); - } - catch (const std::range_error& e) - { - // Store a C++ exception - SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::normInf(Kokkos::View< Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::mag_type *,Kokkos::HostSpace > const &) const", SWIG_IndexError, e.what(), return ); - } - catch (const std::exception& e) - { - // Store a C++ exception - SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::normInf(Kokkos::View< Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::mag_type *,Kokkos::HostSpace > const &) const", SWIG_RuntimeError, e.what(), return ); - } - catch (...) - { - SWIG_exception_impl("Tpetra::MultiVector< SC,LO,GO,NO >::normInf(Kokkos::View< Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::mag_type *,Kokkos::HostSpace > const &) const", SWIG_UnknownError, "An unknown exception occurred", return ); - } - } -} - - SWIGEXPORT void _wrap_TpetraMultiVector_normInf__SWIG_3(SwigClassWrapper const *farg1, SwigArrayWrapper *farg2) { Tpetra::MultiVector< SC,LO,GO,NO > *arg1 = (Tpetra::MultiVector< SC,LO,GO,NO > *) 0 ; Teuchos::ArrayView< Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::mag_type > *arg2 = 0 ; @@ -10583,87 +10225,6 @@ SWIGEXPORT SwigClassWrapper _wrap_new_TpetraCrsMatrix__SWIG_13(SwigClassWrapper } -SWIGEXPORT SwigClassWrapper _wrap_new_TpetraCrsMatrix__SWIG_14(SwigClassWrapper const *farg1, SwigClassWrapper const *farg2, SwigClassWrapper const *farg3) { - SwigClassWrapper fresult ; - Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::crs_graph_type const > *arg1 = 0 ; - Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::local_matrix_type::values_type *arg2 = 0 ; - Teuchos::RCP< Teuchos::ParameterList > *arg3 = 0 ; - Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::crs_graph_type const > tempnull1 ; - Teuchos::RCP< Teuchos::ParameterList > tempnull3 ; - Tpetra::CrsMatrix< SC,LO,GO,NO > *result = 0 ; - - arg1 = farg1->cptr ? static_cast< Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::crs_graph_type const > * >(farg1->cptr) : &tempnull1; - SWIG_check_nonnull(*farg2, "Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::local_matrix_type::values_type const &", "SWIGTYPE_p_KokkosSparse__CrsMatrixT_Tpetra__CrsMatrixT_douC8X8I", "Tpetra::CrsMatrix< SC,LO,GO,NO >::CrsMatrix(Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::crs_graph_type const > const &,Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::local_matrix_type::values_type const &,Teuchos::RCP< Teuchos::ParameterList > const &)", return SwigClassWrapper_uninitialized()); - arg2 = static_cast< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::local_matrix_type::values_type * >(farg2->cptr); - arg3 = farg3->cptr ? static_cast< Teuchos::RCP< Teuchos::ParameterList > * >(farg3->cptr) : &tempnull3; - { - // Make sure no unhandled exceptions exist before performing a new action - SWIG_check_unhandled_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::CrsMatrix(Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::crs_graph_type const > const &,Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::local_matrix_type::values_type const &,Teuchos::RCP< Teuchos::ParameterList > const &)");; - try - { - // Attempt the wrapped function call - result = (Tpetra::CrsMatrix< SC,LO,GO,NO > *)new Tpetra::CrsMatrix< SC,LO,GO,NO >((Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::crs_graph_type const > const &)*arg1,(Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::local_matrix_type::values_type const &)*arg2,(Teuchos::RCP< Teuchos::ParameterList > const &)*arg3); - } - catch (const std::range_error& e) - { - // Store a C++ exception - SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::CrsMatrix(Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::crs_graph_type const > const &,Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::local_matrix_type::values_type const &,Teuchos::RCP< Teuchos::ParameterList > const &)", SWIG_IndexError, e.what(), return SwigClassWrapper_uninitialized()); - } - catch (const std::exception& e) - { - // Store a C++ exception - SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::CrsMatrix(Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::crs_graph_type const > const &,Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::local_matrix_type::values_type const &,Teuchos::RCP< Teuchos::ParameterList > const &)", SWIG_RuntimeError, e.what(), return SwigClassWrapper_uninitialized()); - } - catch (...) - { - SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::CrsMatrix(Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::crs_graph_type const > const &,Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::local_matrix_type::values_type const &,Teuchos::RCP< Teuchos::ParameterList > const &)", SWIG_UnknownError, "An unknown exception occurred", return SwigClassWrapper_uninitialized()); - } - } - fresult.cptr = result ? new Teuchos::RCP< Tpetra::CrsMatrix >(result SWIG_NO_NULL_DELETER_1) : NULL; - fresult.cmemflags = SWIG_MEM_OWN | SWIG_MEM_RVALUE | SWIG_sp_mem_flags; - return fresult; -} - - -SWIGEXPORT SwigClassWrapper _wrap_new_TpetraCrsMatrix__SWIG_15(SwigClassWrapper const *farg1, SwigClassWrapper const *farg2) { - SwigClassWrapper fresult ; - Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::crs_graph_type const > *arg1 = 0 ; - Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::local_matrix_type::values_type *arg2 = 0 ; - Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::crs_graph_type const > tempnull1 ; - Tpetra::CrsMatrix< SC,LO,GO,NO > *result = 0 ; - - arg1 = farg1->cptr ? static_cast< Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::crs_graph_type const > * >(farg1->cptr) : &tempnull1; - SWIG_check_nonnull(*farg2, "Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::local_matrix_type::values_type const &", "SWIGTYPE_p_KokkosSparse__CrsMatrixT_Tpetra__CrsMatrixT_douC8X8I", "Tpetra::CrsMatrix< SC,LO,GO,NO >::CrsMatrix(Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::crs_graph_type const > const &,Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::local_matrix_type::values_type const &)", return SwigClassWrapper_uninitialized()); - arg2 = static_cast< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::local_matrix_type::values_type * >(farg2->cptr); - { - // Make sure no unhandled exceptions exist before performing a new action - SWIG_check_unhandled_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::CrsMatrix(Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::crs_graph_type const > const &,Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::local_matrix_type::values_type const &)");; - try - { - // Attempt the wrapped function call - result = (Tpetra::CrsMatrix< SC,LO,GO,NO > *)new Tpetra::CrsMatrix< SC,LO,GO,NO >((Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::crs_graph_type const > const &)*arg1,(Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::local_matrix_type::values_type const &)*arg2); - } - catch (const std::range_error& e) - { - // Store a C++ exception - SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::CrsMatrix(Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::crs_graph_type const > const &,Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::local_matrix_type::values_type const &)", SWIG_IndexError, e.what(), return SwigClassWrapper_uninitialized()); - } - catch (const std::exception& e) - { - // Store a C++ exception - SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::CrsMatrix(Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::crs_graph_type const > const &,Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::local_matrix_type::values_type const &)", SWIG_RuntimeError, e.what(), return SwigClassWrapper_uninitialized()); - } - catch (...) - { - SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::CrsMatrix(Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::crs_graph_type const > const &,Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::local_matrix_type::values_type const &)", SWIG_UnknownError, "An unknown exception occurred", return SwigClassWrapper_uninitialized()); - } - } - fresult.cptr = result ? new Teuchos::RCP< Tpetra::CrsMatrix >(result SWIG_NO_NULL_DELETER_1) : NULL; - fresult.cmemflags = SWIG_MEM_OWN | SWIG_MEM_RVALUE | SWIG_sp_mem_flags; - return fresult; -} - - SWIGEXPORT SwigClassWrapper _wrap_new_TpetraCrsMatrix__SWIG_16(SwigClassWrapper const *farg1, SwigClassWrapper const *farg2, SwigArrayWrapper *farg3, SwigArrayWrapper *farg4, SwigArrayWrapper *farg5, SwigClassWrapper const *farg6) { SwigClassWrapper fresult ; Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > *arg1 = 0 ; @@ -12947,41 +12508,6 @@ SWIGEXPORT void _wrap_TpetraCrsMatrix_getGlobalRowView(SwigClassWrapper const *f } -SWIGEXPORT void _wrap_TpetraCrsMatrix_getLocalDiagOffsets(SwigClassWrapper const *farg1, SwigClassWrapper const *farg2) { - Tpetra::CrsMatrix< SC,LO,GO,NO > *arg1 = (Tpetra::CrsMatrix< SC,LO,GO,NO > *) 0 ; - Teuchos::ArrayRCP< std::size_t > *arg2 = 0 ; - Teuchos::RCP< Tpetra::CrsMatrix< SC,LO,GO,NO > const > *smartarg1 ; - - smartarg1 = static_cast< Teuchos::RCP >* >(farg1->cptr); - arg1 = smartarg1 ? const_cast< Tpetra::CrsMatrix* >(smartarg1->get()) : NULL; - SWIG_check_mutable_nonnull(*farg2, "Teuchos::ArrayRCP< std::size_t > &", "SWIGTYPE_p_Teuchos__ArrayRCPT_unsigned_long_t", "Tpetra::CrsMatrix< SC,LO,GO,NO >::getLocalDiagOffsets(Teuchos::ArrayRCP< std::size_t > &) const", return ); - arg2 = static_cast< Teuchos::ArrayRCP< std::size_t > * >(farg2->cptr); - { - // Make sure no unhandled exceptions exist before performing a new action - SWIG_check_unhandled_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::getLocalDiagOffsets(Teuchos::ArrayRCP< std::size_t > &) const");; - try - { - // Attempt the wrapped function call - ((Tpetra::CrsMatrix< SC,LO,GO,NO > const *)arg1)->getLocalDiagOffsets(*arg2); - } - catch (const std::range_error& e) - { - // Store a C++ exception - SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::getLocalDiagOffsets(Teuchos::ArrayRCP< std::size_t > &) const", SWIG_IndexError, e.what(), return ); - } - catch (const std::exception& e) - { - // Store a C++ exception - SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::getLocalDiagOffsets(Teuchos::ArrayRCP< std::size_t > &) const", SWIG_RuntimeError, e.what(), return ); - } - catch (...) - { - SWIG_exception_impl("Tpetra::CrsMatrix< SC,LO,GO,NO >::getLocalDiagOffsets(Teuchos::ArrayRCP< std::size_t > &) const", SWIG_UnknownError, "An unknown exception occurred", return ); - } - } -} - - SWIGEXPORT void _wrap_TpetraCrsMatrix_apply__SWIG_0(SwigClassWrapper const *farg1, SwigClassWrapper const *farg2, SwigClassWrapper const *farg3, int const *farg4, double const *farg5, double const *farg6) { Tpetra::CrsMatrix< SC,LO,GO,NO > *arg1 = (Tpetra::CrsMatrix< SC,LO,GO,NO > *) 0 ; Tpetra::MultiVector< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode > *arg2 = 0 ; diff --git a/swig_hash b/swig_hash index b887b0d5..04230a26 100644 --- a/swig_hash +++ b/swig_hash @@ -1,2 +1,3 @@ cbc70530881be3d3ae0414afd44d4b98f4ee3b00 f7b89565dfc953a5b5c5b8c580d96789e8a95948 +7ecfd34fd503e89000ffa50a2926491c07d3e782 From 6323e1fb5307091879f8dbd9f1387770830f8493 Mon Sep 17 00:00:00 2001 From: Seth R Johnson Date: Thu, 9 May 2019 12:35:47 -0400 Subject: [PATCH 37/40] Silence warnings --- src/tpetra/src/Tpetra_CrsMatrix.i | 4 ++++ 1 file changed, 4 insertions(+) diff --git a/src/tpetra/src/Tpetra_CrsMatrix.i b/src/tpetra/src/Tpetra_CrsMatrix.i index fbf34d23..98ac1458 100644 --- a/src/tpetra/src/Tpetra_CrsMatrix.i +++ b/src/tpetra/src/Tpetra_CrsMatrix.i @@ -32,6 +32,10 @@ %ignore Tpetra::CrsMatrix::unpackAndCombineNew; %ignore Tpetra::CrsMatrix::useNewInterface; +// Don't warn about ignored overloads +%warnfilter(SWIGWARN_LANG_OVERLOAD_IGNORED) Tpetra::CrsMatrix::sumIntoGlobalValues; +%warnfilter(SWIGWARN_LANG_OVERLOAD_IGNORED) Tpetra::CrsMatrix::sumIntoLocalValues; + // ======================================================================= // Postpone temporarily // ======================================================================= From 7147ce9bac8e29a45fb7b407ef38a832c068a09d Mon Sep 17 00:00:00 2001 From: Seth R Johnson Date: Thu, 9 May 2019 12:37:27 -0400 Subject: [PATCH 38/40] Replace manual `%ignore` with autoignore --- src/tpetra/src/Tpetra_CrsMatrix.i | 19 ------------ src/tpetra/src/swig/fortpetra.F90 | 31 ++++++++++--------- src/tpetra/src/swig/fortpetraFORTRAN_wrap.cxx | 6 ++-- 3 files changed, 19 insertions(+), 37 deletions(-) diff --git a/src/tpetra/src/Tpetra_CrsMatrix.i b/src/tpetra/src/Tpetra_CrsMatrix.i index 98ac1458..293bc8f7 100644 --- a/src/tpetra/src/Tpetra_CrsMatrix.i +++ b/src/tpetra/src/Tpetra_CrsMatrix.i @@ -39,25 +39,6 @@ // ======================================================================= // Postpone temporarily // ======================================================================= -%ignore Tpetra::CrsMatrix::CrsMatrix (const Teuchos::RCP& rowMap, - const Teuchos::RCP& colMap, - const typename local_matrix_type::row_map_type& rowPointers, - const typename local_graph_type::entries_type::non_const_type& columnIndices, - const typename local_matrix_type::values_type& values, - const Teuchos::RCP& params = Teuchos::null); // needs Kokkos containers -%ignore Tpetra::CrsMatrix::CrsMatrix (const Teuchos::RCP& rowMap, - const Teuchos::RCP& colMap, - const local_matrix_type& lclMatrix, - const Teuchos::RCP& params = Teuchos::null); // needs Kokkos containers -%ignore Tpetra::CrsMatrix::CrsMatrix (const local_matrix_type& lclMatrix, - const Teuchos::RCP& rowMap, - const Teuchos::RCP& colMap = Teuchos::null, - const Teuchos::RCP& domainMap = Teuchos::null, - const Teuchos::RCP& rangeMap = Teuchos::null, - const Teuchos::RCP& params = Teuchos::null); // needs Kokkos containers -%ignore Tpetra::CrsMatrix::setAllValues(const typename local_matrix_type::row_map_type& ptr, - const typename local_graph_type::entries_type::non_const_type& ind, - const typename local_matrix_type::values_type& val); // needs Kokkos::View %ignore Tpetra::CrsMatrix::insertGlobalValues (const GlobalOrdinal globalRow, const LocalOrdinal numEnt, const Scalar vals[], const GlobalOrdinal inds[]); // prefer ArrayView version %ignore Tpetra::CrsMatrix::insertLocalValues (const LocalOrdinal localRow, const LocalOrdinal numEnt, const Scalar vals[], const LocalOrdinal cols[]); // prefer ArrayView version %ignore Tpetra::CrsMatrix::replaceGlobalValues (const GlobalOrdinal globalRow, const typename UnmanagedView< GlobalIndicesViewType >::type &inputInds, const typename UnmanagedView< ImplScalarViewType >::type &inputVals) const; // needs Kokkos::UnmanagedView diff --git a/src/tpetra/src/swig/fortpetra.F90 b/src/tpetra/src/swig/fortpetra.F90 index b894b637..21512c0f 100644 --- a/src/tpetra/src/swig/fortpetra.F90 +++ b/src/tpetra/src/swig/fortpetra.F90 @@ -472,7 +472,7 @@ module fortpetra procedure, private :: swigf_TpetraCrsMatrix_sumIntoLocalValues__SWIG_0 procedure :: setAllToScalar => swigf_TpetraCrsMatrix_setAllToScalar procedure :: scale => swigf_TpetraCrsMatrix_scale - procedure :: setAllValues => swigf_TpetraCrsMatrix_setAllValues + procedure, private :: swigf_TpetraCrsMatrix_setAllValues__SWIG_1 procedure :: globalAssemble => swigf_TpetraCrsMatrix_globalAssemble procedure, private :: swigf_TpetraCrsMatrix_resumeFill__SWIG_0 procedure, private :: swigf_TpetraCrsMatrix_resumeFill__SWIG_1 @@ -549,6 +549,7 @@ module fortpetra swigf_TpetraCrsMatrix_replaceLocalValues__SWIG_2 generic :: sumIntoGlobalValues => swigf_TpetraCrsMatrix_sumIntoGlobalValues__SWIG_0 generic :: sumIntoLocalValues => swigf_TpetraCrsMatrix_sumIntoLocalValues__SWIG_0 + generic :: setAllValues => swigf_TpetraCrsMatrix_setAllValues__SWIG_1 generic :: fillComplete => swigf_TpetraCrsMatrix_fillComplete__SWIG_0, swigf_TpetraCrsMatrix_fillComplete__SWIG_1, & swigf_TpetraCrsMatrix_fillComplete__SWIG_2, swigf_TpetraCrsMatrix_fillComplete__SWIG_3 generic :: expertStaticFillComplete => swigf_TpetraCrsMatrix_expertStaticFillComplete__SWIG_0, & @@ -575,8 +576,8 @@ module fortpetra module procedure swigf_new_TpetraCrsMatrix__SWIG_11 module procedure swigf_new_TpetraCrsMatrix__SWIG_12 module procedure swigf_new_TpetraCrsMatrix__SWIG_13 - module procedure swigf_new_TpetraCrsMatrix__SWIG_16 - module procedure swigf_new_TpetraCrsMatrix__SWIG_17 + module procedure swigf_new_TpetraCrsMatrix__SWIG_18 + module procedure swigf_new_TpetraCrsMatrix__SWIG_19 end interface public :: operator_to_matrix public :: matrix_to_operator @@ -3089,8 +3090,8 @@ function swigc_new_TpetraCrsMatrix__SWIG_13(farg1) & type(SwigClassWrapper) :: fresult end function -function swigc_new_TpetraCrsMatrix__SWIG_16(farg1, farg2, farg3, farg4, farg5, farg6) & -bind(C, name="_wrap_new_TpetraCrsMatrix__SWIG_16") & +function swigc_new_TpetraCrsMatrix__SWIG_18(farg1, farg2, farg3, farg4, farg5, farg6) & +bind(C, name="_wrap_new_TpetraCrsMatrix__SWIG_18") & result(fresult) use, intrinsic :: ISO_C_BINDING import :: swigclasswrapper @@ -3104,8 +3105,8 @@ function swigc_new_TpetraCrsMatrix__SWIG_16(farg1, farg2, farg3, farg4, farg5, f type(SwigClassWrapper) :: fresult end function -function swigc_new_TpetraCrsMatrix__SWIG_17(farg1, farg2, farg3, farg4, farg5) & -bind(C, name="_wrap_new_TpetraCrsMatrix__SWIG_17") & +function swigc_new_TpetraCrsMatrix__SWIG_19(farg1, farg2, farg3, farg4, farg5) & +bind(C, name="_wrap_new_TpetraCrsMatrix__SWIG_19") & result(fresult) use, intrinsic :: ISO_C_BINDING import :: swigclasswrapper @@ -3228,8 +3229,8 @@ subroutine swigc_TpetraCrsMatrix_scale(farg1, farg2) & real(C_DOUBLE), intent(in) :: farg2 end subroutine -subroutine swigc_TpetraCrsMatrix_setAllValues(farg1, farg2, farg3, farg4) & -bind(C, name="_wrap_TpetraCrsMatrix_setAllValues") +subroutine swigc_TpetraCrsMatrix_setAllValues__SWIG_1(farg1, farg2, farg3, farg4) & +bind(C, name="_wrap_TpetraCrsMatrix_setAllValues__SWIG_1") use, intrinsic :: ISO_C_BINDING import :: swigclasswrapper import :: swigarraywrapper @@ -8613,7 +8614,7 @@ function swigf_new_TpetraCrsMatrix__SWIG_13(graph) & self%swigdata = fresult end function -function swigf_new_TpetraCrsMatrix__SWIG_16(rowmap, colmap, rowpointers, columnindices, values, params) & +function swigf_new_TpetraCrsMatrix__SWIG_18(rowmap, colmap, rowpointers, columnindices, values, params) & result(self) use, intrinsic :: ISO_C_BINDING type(TpetraCrsMatrix) :: self @@ -8661,11 +8662,11 @@ function swigf_new_TpetraCrsMatrix__SWIG_16(rowmap, colmap, rowpointers, columni farg5%size = 0 end if farg6 = params%swigdata -fresult = swigc_new_TpetraCrsMatrix__SWIG_16(farg1, farg2, farg3, farg4, farg5, farg6) +fresult = swigc_new_TpetraCrsMatrix__SWIG_18(farg1, farg2, farg3, farg4, farg5, farg6) self%swigdata = fresult end function -function swigf_new_TpetraCrsMatrix__SWIG_17(rowmap, colmap, rowpointers, columnindices, values) & +function swigf_new_TpetraCrsMatrix__SWIG_19(rowmap, colmap, rowpointers, columnindices, values) & result(self) use, intrinsic :: ISO_C_BINDING type(TpetraCrsMatrix) :: self @@ -8710,7 +8711,7 @@ function swigf_new_TpetraCrsMatrix__SWIG_17(rowmap, colmap, rowpointers, columni farg5%data = c_null_ptr farg5%size = 0 end if -fresult = swigc_new_TpetraCrsMatrix__SWIG_17(farg1, farg2, farg3, farg4, farg5) +fresult = swigc_new_TpetraCrsMatrix__SWIG_19(farg1, farg2, farg3, farg4, farg5) self%swigdata = fresult end function @@ -8997,7 +8998,7 @@ subroutine swigf_TpetraCrsMatrix_scale(self, alpha) call swigc_TpetraCrsMatrix_scale(farg1, farg2) end subroutine -subroutine swigf_TpetraCrsMatrix_setAllValues(self, ptr, ind, val) +subroutine swigf_TpetraCrsMatrix_setAllValues__SWIG_1(self, ptr, ind, val) use, intrinsic :: ISO_C_BINDING class(TpetraCrsMatrix), intent(in) :: self integer(C_LONG), dimension(:), target :: ptr @@ -9036,7 +9037,7 @@ subroutine swigf_TpetraCrsMatrix_setAllValues(self, ptr, ind, val) farg4%data = c_null_ptr farg4%size = 0 end if -call swigc_TpetraCrsMatrix_setAllValues(farg1, farg2, farg3, farg4) +call swigc_TpetraCrsMatrix_setAllValues__SWIG_1(farg1, farg2, farg3, farg4) end subroutine subroutine swigf_TpetraCrsMatrix_globalAssemble(self) diff --git a/src/tpetra/src/swig/fortpetraFORTRAN_wrap.cxx b/src/tpetra/src/swig/fortpetraFORTRAN_wrap.cxx index ef367ced..02fe211e 100644 --- a/src/tpetra/src/swig/fortpetraFORTRAN_wrap.cxx +++ b/src/tpetra/src/swig/fortpetraFORTRAN_wrap.cxx @@ -10225,7 +10225,7 @@ SWIGEXPORT SwigClassWrapper _wrap_new_TpetraCrsMatrix__SWIG_13(SwigClassWrapper } -SWIGEXPORT SwigClassWrapper _wrap_new_TpetraCrsMatrix__SWIG_16(SwigClassWrapper const *farg1, SwigClassWrapper const *farg2, SwigArrayWrapper *farg3, SwigArrayWrapper *farg4, SwigArrayWrapper *farg5, SwigClassWrapper const *farg6) { +SWIGEXPORT SwigClassWrapper _wrap_new_TpetraCrsMatrix__SWIG_18(SwigClassWrapper const *farg1, SwigClassWrapper const *farg2, SwigArrayWrapper *farg3, SwigArrayWrapper *farg4, SwigArrayWrapper *farg5, SwigClassWrapper const *farg6) { SwigClassWrapper fresult ; Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > *arg1 = 0 ; Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > *arg2 = 0 ; @@ -10291,7 +10291,7 @@ SWIGEXPORT SwigClassWrapper _wrap_new_TpetraCrsMatrix__SWIG_16(SwigClassWrapper } -SWIGEXPORT SwigClassWrapper _wrap_new_TpetraCrsMatrix__SWIG_17(SwigClassWrapper const *farg1, SwigClassWrapper const *farg2, SwigArrayWrapper *farg3, SwigArrayWrapper *farg4, SwigArrayWrapper *farg5) { +SWIGEXPORT SwigClassWrapper _wrap_new_TpetraCrsMatrix__SWIG_19(SwigClassWrapper const *farg1, SwigClassWrapper const *farg2, SwigArrayWrapper *farg3, SwigArrayWrapper *farg4, SwigArrayWrapper *farg5) { SwigClassWrapper fresult ; Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > *arg1 = 0 ; Teuchos::RCP< Tpetra::CrsMatrix< double,int,long long,Kokkos::Compat::KokkosSerialWrapperNode >::map_type const > *arg2 = 0 ; @@ -10796,7 +10796,7 @@ SWIGEXPORT void _wrap_TpetraCrsMatrix_scale(SwigClassWrapper const *farg1, doubl } -SWIGEXPORT void _wrap_TpetraCrsMatrix_setAllValues(SwigClassWrapper const *farg1, SwigArrayWrapper *farg2, SwigArrayWrapper *farg3, SwigArrayWrapper *farg4) { +SWIGEXPORT void _wrap_TpetraCrsMatrix_setAllValues__SWIG_1(SwigClassWrapper const *farg1, SwigArrayWrapper *farg2, SwigArrayWrapper *farg3, SwigArrayWrapper *farg4) { Tpetra::CrsMatrix< SC,LO,GO,NO > *arg1 = (Tpetra::CrsMatrix< SC,LO,GO,NO > *) 0 ; Teuchos::ArrayRCP< std::size_t > *arg2 = 0 ; Teuchos::ArrayRCP< int > *arg3 = 0 ; From 5f137bc4b5735097d15ff14d86d9f37e56e7167c Mon Sep 17 00:00:00 2001 From: Seth R Johnson Date: Thu, 9 May 2019 12:56:28 -0400 Subject: [PATCH 39/40] Fix typos --- src/tpetra/src/Tpetra_Map.i | 1 - swig_hash | 2 -- 2 files changed, 3 deletions(-) diff --git a/src/tpetra/src/Tpetra_Map.i b/src/tpetra/src/Tpetra_Map.i index a79e33f3..523aa12a 100644 --- a/src/tpetra/src/Tpetra_Map.i +++ b/src/tpetra/src/Tpetra_Map.i @@ -21,7 +21,6 @@ // ======================================================================= // Ignore permanently // ======================================================================= -%fortranonlywrapped Tpetra::Map::Map; %ignore Tpetra::Map::Map(const global_size_t numGlobalElements, const GlobalOrdinal indexList[], const LocalOrdinal indexListSize, const GlobalOrdinal indexBase, const Teuchos::RCP< const Teuchos::Comm< int > > &comm); // superseded by Teuchos::ArrayView version diff --git a/swig_hash b/swig_hash index 04230a26..f99dbb8b 100644 --- a/swig_hash +++ b/swig_hash @@ -1,3 +1 @@ -cbc70530881be3d3ae0414afd44d4b98f4ee3b00 -f7b89565dfc953a5b5c5b8c580d96789e8a95948 7ecfd34fd503e89000ffa50a2926491c07d3e782 From 17ee435442e5b8e857c474ee02fce68e15a5fc75 Mon Sep 17 00:00:00 2001 From: Seth R Johnson Date: Fri, 10 May 2019 08:43:48 -0400 Subject: [PATCH 40/40] Fix wrapping of NOX return status type --- src/belos/src/swig/forbelos.F90 | 10 +++---- src/interface/src/nox.i | 18 ++++++------ src/interface/src/swig/fortrilinos.F90 | 29 +++++++++---------- .../src/swig/fortrilinosFORTRAN_wrap.cxx | 4 +-- src/tpetra/src/swig/fortpetra.F90 | 10 +++---- src/utils/src/swig/forerror.F90 | 10 +++---- swig_hash | 2 +- 7 files changed, 41 insertions(+), 42 deletions(-) diff --git a/src/belos/src/swig/forbelos.F90 b/src/belos/src/swig/forbelos.F90 index c6a37d2c..b3364d6b 100644 --- a/src/belos/src/swig/forbelos.F90 +++ b/src/belos/src/swig/forbelos.F90 @@ -143,6 +143,11 @@ module forbelos ! WRAPPER DECLARATIONS interface + subroutine SWIG_free(cptr) & + bind(C, name="free") + use, intrinsic :: ISO_C_BINDING + type(C_PTR), value :: cptr +end subroutine function swigc_convertReturnTypeToString(farg1) & bind(C, name="_wrap_convertReturnTypeToString") & result(fresult) @@ -152,11 +157,6 @@ function swigc_convertReturnTypeToString(farg1) & type(SwigArrayWrapper) :: fresult end function - subroutine SWIG_free(cptr) & - bind(C, name="free") - use, intrinsic :: ISO_C_BINDING - type(C_PTR), value :: cptr -end subroutine function swigc_convertStatusTypeToString(farg1) & bind(C, name="_wrap_convertStatusTypeToString") & result(fresult) diff --git a/src/interface/src/nox.i b/src/interface/src/nox.i index 09906363..be774685 100644 --- a/src/interface/src/nox.i +++ b/src/interface/src/nox.i @@ -370,15 +370,6 @@ subroutine init_ForModelEvaluator(self) end subroutine %} -%{ -#include "nox_solver.hpp" -%} - -%include "nox_solver.hpp" - -%teuchos_rcp(ForTrilinos::NOXSolver) -%template(NOXSolver) ForTrilinos::NOXSolver; - // All enums should be prefaced with NOX %rename("NOX%s", %$isenumitem) ""; %rename("NOX%s", %$isenum) ""; @@ -392,3 +383,12 @@ end subroutine %ignore NOX::StatusTest::operator<<; %include "NOX_StatusTest_Generic.H" + +%{ +#include "nox_solver.hpp" +%} + +%include "nox_solver.hpp" + +%teuchos_rcp(ForTrilinos::NOXSolver) +%template(NOXSolver) ForTrilinos::NOXSolver; diff --git a/src/interface/src/swig/fortrilinos.F90 b/src/interface/src/swig/fortrilinos.F90 index 0e42122c..e19683a9 100644 --- a/src/interface/src/swig/fortrilinos.F90 +++ b/src/interface/src/swig/fortrilinos.F90 @@ -112,20 +112,6 @@ module fortrilinos public :: init_ForModelEvaluator -integer, parameter, public :: SWIGTYPE_NOX__StatusTest__StatusType = C_INT - ! class ForTrilinos::NOXSolver< SC,LO,GO,NO > - type, public :: NOXSolver - type(SwigClassWrapper), public :: swigdata - contains - procedure :: setup => swigf_NOXSolver_setup - procedure :: solve => swigf_NOXSolver_solve - procedure :: release => swigf_release_NOXSolver - procedure, private :: swigf_NOXSolver_op_assign__ - generic :: assignment(=) => swigf_NOXSolver_op_assign__ - end type NOXSolver - interface NOXSolver - module procedure swigf_create_NOXSolver - end interface ! enum NOX::StatusTest::StatusType enum, bind(c) enumerator :: NOXUnevaluated = -2 @@ -143,6 +129,19 @@ module fortrilinos end enum integer, parameter, public :: NOXCheckType = kind(NOXComplete) public :: NOXComplete, NOXMinimal, NOXNone + ! class ForTrilinos::NOXSolver< SC,LO,GO,NO > + type, public :: NOXSolver + type(SwigClassWrapper), public :: swigdata + contains + procedure :: setup => swigf_NOXSolver_setup + procedure :: solve => swigf_NOXSolver_solve + procedure :: release => swigf_release_NOXSolver + procedure, private :: swigf_NOXSolver_op_assign__ + generic :: assignment(=) => swigf_NOXSolver_op_assign__ + end type NOXSolver + interface NOXSolver + module procedure swigf_create_NOXSolver + end interface ! WRAPPER DECLARATIONS interface @@ -1312,7 +1311,7 @@ subroutine swigf_NOXSolver_setup(self, plist) function swigf_NOXSolver_solve(self) & result(swig_result) use, intrinsic :: ISO_C_BINDING -integer(SWIGTYPE_NOX__StatusTest__StatusType) :: swig_result +integer(NOXStatusType) :: swig_result class(NOXSolver), intent(in) :: self integer(C_INT) :: fresult type(SwigClassWrapper) :: farg1 diff --git a/src/interface/src/swig/fortrilinosFORTRAN_wrap.cxx b/src/interface/src/swig/fortrilinosFORTRAN_wrap.cxx index c1c170d4..def6d3d0 100644 --- a/src/interface/src/swig/fortrilinosFORTRAN_wrap.cxx +++ b/src/interface/src/swig/fortrilinosFORTRAN_wrap.cxx @@ -605,10 +605,10 @@ SwigClassWrapper swigd_ForModelEvaluator_create_operator( #define SWIG_NO_NULL_DELETER_SWIG_POINTER_OWN -#include "nox_solver.hpp" +#include "NOX_StatusTest_Generic.H" -#include "NOX_StatusTest_Generic.H" +#include "nox_solver.hpp" extern "C" { SWIGEXPORT SwigClassWrapper _wrap_new_TrilinosSolver() { diff --git a/src/tpetra/src/swig/fortpetra.F90 b/src/tpetra/src/swig/fortpetra.F90 index 21512c0f..0b37fb81 100644 --- a/src/tpetra/src/swig/fortpetra.F90 +++ b/src/tpetra/src/swig/fortpetra.F90 @@ -646,6 +646,11 @@ subroutine swigc_setCombineModeParameter(farg1, farg2) & type(SwigArrayWrapper) :: farg2 end subroutine + subroutine SWIG_free(cptr) & + bind(C, name="free") + use, intrinsic :: ISO_C_BINDING + type(C_PTR), value :: cptr +end subroutine function swigc_combineModeToString(farg1) & bind(C, name="_wrap_combineModeToString") & result(fresult) @@ -655,11 +660,6 @@ function swigc_combineModeToString(farg1) & type(SwigArrayWrapper) :: fresult end function - subroutine SWIG_free(cptr) & - bind(C, name="free") - use, intrinsic :: ISO_C_BINDING - type(C_PTR), value :: cptr -end subroutine function swigc_new_TpetraMap__SWIG_1(farg1, farg3, farg4) & bind(C, name="_wrap_new_TpetraMap__SWIG_1") & result(fresult) diff --git a/src/utils/src/swig/forerror.F90 b/src/utils/src/swig/forerror.F90 index d8d057fd..aa30a54f 100644 --- a/src/utils/src/swig/forerror.F90 +++ b/src/utils/src/swig/forerror.F90 @@ -26,6 +26,11 @@ module forerror ! WRAPPER DECLARATIONS interface + subroutine SWIG_free(cptr) & + bind(C, name="free") + use, intrinsic :: ISO_C_BINDING + type(C_PTR), value :: cptr +end subroutine function swigc_fortrilinos_get_serr() & bind(C, name="_wrap_fortrilinos_get_serr") & result(fresult) @@ -34,11 +39,6 @@ function swigc_fortrilinos_get_serr() & type(SwigArrayWrapper) :: fresult end function - subroutine SWIG_free(cptr) & - bind(C, name="free") - use, intrinsic :: ISO_C_BINDING - type(C_PTR), value :: cptr -end subroutine end interface diff --git a/swig_hash b/swig_hash index f99dbb8b..d0c28557 100644 --- a/swig_hash +++ b/swig_hash @@ -1 +1 @@ -7ecfd34fd503e89000ffa50a2926491c07d3e782 +15e6ed597386e203d0348d94c308e178b80ec5bb