SHA256
10
0
forked from pool/petsc

79 Commits

Author SHA256 Message Date
f160318192 * Use COPTFLAGS, FOPTFLAGS, and CXXOPTFLAGS to pass rpm optflags to compilers instead of directly setting CFLAGS, FFLAGS, or CXXFLAGS; this is recommended by upstream and fixes build failures seen when compiling fortran modules on Leap 16 and older (see https://gitlab.com/petsc/petsc/-/issues/1727).
* Changes PETSC_ARCH definition to %_arch instead of linux-gnu-c-opt; this is in line with upstream's recommendation and what Fedora does and should be ok for openSUSE not that we no longer use hpc macros.
* Modify petsc-fix-libdir.patch to use sysconfig.get_config_vars('platlibdir') instead of sys.platlibdir for compatibility with python 3.6 (fix FTBFS on 15.6 and older).
* Actually bail out before running make when configuring fails.

OBS-URL: https://build.opensuse.org/package/show/science/petsc?expand=0&rev=147
2025-05-20 05:43:23 +00:00
6f11d36799 OBS-URL: https://build.opensuse.org/package/show/science/petsc?expand=0&rev=145 2025-04-11 05:38:16 +00:00
42c154e7d0 * Update to version 3.23.0.
* Add petsc-fix-install-libdir.patch: Install libraries to system arch compatible lib dir (e.g. 'lib64' for x86_64).
* Drop and add hashbangs as required for non-exec and exec python scripts respectively.
* Implement a %check section and run make check.
* Drop explicit specification of mpi library paths and allow `%setup_openmpi` to export relevant paths.
* Fix an incorrect file encoding.

OBS-URL: https://build.opensuse.org/package/show/science/petsc?expand=0&rev=144
2025-04-11 05:32:25 +00:00
541119c734 - Fix issues package naming and install paths introduced during gnu-hpc removal
OBS-URL: https://build.opensuse.org/package/show/science/petsc?expand=0&rev=142
2025-04-01 13:20:38 +00:00
Ana Guerrero
ac757de13e - Disable and remove support for gnu-hpc build flavours (bsc#1239982)
- Add openmpi5 build flavour

OBS-URL: https://build.opensuse.org/package/show/science/petsc?expand=0&rev=141
2025-04-01 08:41:48 +00:00
26deaf79ef Accepting request 1235213 from home:StefanBruens:branches:science
- Update to version 3.22:
  * General:
    + Add -mpiuni-allow-multiprocess-launch to allow mpiexec to
      launch multiple indendent MPI-Uni jobs. Previously a sanity
      check error message was always produced
  * Configure/Build:
    + Add --with-openmp-kernels
    + Update to work with python-3.13
    + Change MPIU_Allreduce() to always returns an MPI error
      code that should be checked with PetscCallMPI()
    + Add PetscCallReturnMPI(), PetscCallMPIReturnMPI(), and
      PetscCheckReturnMPI() to check for in PETSc provided MPI
      callbacks
  * Sys:
    + Add PetscPragmaUseOMPKernels
    + Deprecate PetscOptionsRestoreViewer() in favor of
      PetscViewerDestroy()
    + Deprecate PetscOptionsGetViewer() and PetscOptionsGetViewers()
      in favor of PetscOptionsCreateViewer() and
      PetscOptionsCreateViewers()
    + Deprecate PetscOptionsPushGetViewerOff(),
      PetscOptionsPopGetViewerOff(), and PetscOptionsGetViewerOff()
      in favor of PetscOptionsPushCreateViewerOff(),
      PetscOptionsPopCreateViewerOff(), and
      PetscOptionsGetCreateViewerOff()
    + Add PetscObjectContainerCompose() and
      PetscObjectContainerQuery()
    + Add size_t argument to PetscMPIErrorString()
    + Add PetscCallExternalAbort() for calling external library
      functions from functions not returning PetscErrorCode
    + Add PetscRandomSetOptionsPrefix()
    + Add PetscOptionsGetBool3() to get a ternary logical value
      from a command line option
  * PetscViewer:
    + Add PetscViewerASCIIStdoutSetFileUnit()
    + Add PetscShmgetAllocateArrayScalar(),
      PetscShmgetDeallocateArrayScalar(),
      PetscShmgetAllocateArrayInt(), and
      PetscShmgetDeallocateArrayInt() for Fortran
  * VecScatter / PetscSF:
    + Add PetscSFRegisterPersistent() and
      PetscSFDeregisterPersistent() for safe optimization of
      persistent communication
  * Vec:
    + The IS passed to VecISAXPY() and VecISCopy(). VecISSet() and
      VecISShift() must have the same communicator of the vectors used
      Make VecLock API active in optimized mode
    + VecNestSetSubVec() and VecNestSetSubVecs() now take references
      to input vectors rather than creating duplicates Deprecate
      VecSetInf() with VecFlag()
  * Mat:
    + Change MatProductSetFill() to support PETSC_DETERMINE and
      PETSC_CURRENT. MatMatMult() and its friends and relations now
      accept PETSC_DETERMINE and PETSC_CURRENT in the fill argument.
      PETSC_DEFAULT is deprecated for those functions
    + Change the default MatType of the output Mat of
      MatSchurComplementComputeExplicitOperator() to be MATDENSE.
      It may be changed from the command line, e.g.,
      -fieldsplit_1_explicit_operator_mat_type aij
    + Add MATOP_GET_BLOCK_DIAGONAL and MATOP_GET_VBLOCK_DIAGONAL to
      set methods returning the diagonal point blocks of a matrix
   * PC:
     + Add support in PCFieldSplitSetFields() including with
       -pc_fieldsplit_%d_fields fields for MATNEST,  making it
       possible to utilize multiple levels of PCFIELDSPLIT with
       MATNEST from the command line
     + Add PCCompositeSpecialSetAlphaMat() API to use a matrix
       other than the identity in preconditioners based on an
       alternating direction iteration, e.g., setting M for
       P = (A + alpha M) M^{-1} (alpha M + B)
     + Reuse the result of T = A_{00}^-1 A_{01} in
       PCApply_FieldSplit_Schur with -pc_fieldsplit_schur_fact_type
       full
     + Change the option database keys for coarsening for PCGAMG to
       use the prefix -pc_gamg_, for example -pc_gamg_mat_coarsen_type
     + Add PCGAMGSetGraphSymmetrize() and -pc_gamg_graph_symmetrize to
       control symmetrization when coarsening the graph Add
       -pc_hypre_type ilu with -pc_hypre_ilu_type,
       -pc_hypre_ilu_iterative_setup_type,
       -pc_hypre_ilu_iterative_setup_maxiter,
       -pc_hypre_ilu_iterative_setup_tolerance,
       -pc_hypre_ilu_print_level, -pc_hypre_ilu_logging,
       -pc_hypre_ilu_level, -pc_hypre_ilu_max_nnz_per_row,
       -pc_hypre_ilu_tol, -pc_hypre_ilu_maxiter,
       -pc_hypre_ilu_drop_threshold, -pc_hypre_ilu_tri_solve,
       -pc_hypre_ilu_lower_jacobi_iters,
       -pc_hypre_ilu_upper_jacobi_iters, and
       -pc_hypre_ilu_local_reordering
     + Improve -pc_type boomeramg with
       -pc_hypre_boomeramg_smooth_num_sweeps,
       -pc_hypre_boomeramg_ilu_type,
       -pc_hypre_boomeramg_ilu_iterative_setup_type,
       -pc_hypre_boomeramg_ilu_iterative_setup_option,
       -pc_hypre_boomeramg_ilu_iterative_setup_maxiter,
       -pc_hypre_boomeramg_ilu_iterative_setup_tolerance,
       -pc_hypre_boomeramg_ilu_print_level,
       -pc_hypre_boomeramg_ilu_logging, -pc_hypre_boomeramg_ilu_level,
       -pc_hypre_boomeramg_ilu_max_nnz_per_row,
       -pc_hypre_boomeramg_ilu_maxiter,
       -pc_hypre_boomeramg_ilu_drop_tol,
       -pc_hypre_boomeramg_ilu_tri_solve,
       -pc_hypre_boomeramg_ilu_lower_jacobi_iters,
       -pc_hypre_boomeramg_ilu_upper_jacobi_iters, and
       -pc_hypre_boomeramg_ilu_local_reordering
  * KSP:
    + Add support for PETSC_DETERMINE as an argument to
      KSPSetTolerances() to set the parameter back to its initial
      value when the object's type was set
    + Deprecate PETSC_DEFAULT in favor of PETSC_CURRENT for
      KSPSetTolerances()
  * SNES:
    + Add support for PETSC_DETERMINE as an argument to
      SNESSetTolerances() to set the parameter back to its initial
      value when the object's type was set
    + Deprecate PETSC_DEFAULT in favor of PETSC_CURRENT for
      SNESSetTolerances()
    + Add DMAdaptorMonitor(), DMAdaptorMonitorSet(),
      DMAdaptorMonitorCancel(), and DMAdaptorMonitorSetFromOptions()
    + Add DMAdaptorMonitorSize(), DMAdaptorMonitorError(),
      DMAdaptorMonitorErrorDraw(),
      DMAdaptorMonitorErrorDrawLGCreate(), and
      DMAdaptorMonitorErrorDrawLG()
    + Add DMAdaptorMonitorRegister(), DMAdaptorMonitorRegisterAll(),
      and DMAdaptorMonitorRegisterDestroy()
    + Add DMAdaptorGetCriterion() and DMAdaptorSetCriterion()
    + Add DMAdaptorSetOptionsPrefix()
    + Add Newton's method with arc length continuation: SNESNEWTONAL
      with SNESNewtonALSetFunction(), SNESNewtonALGetFunction(),
      SNESNewtonALComputeFunction(), SNESNewtonALGetLoadParameter(),
      and SNESNewtonALSetCorrectionType()
    + Add SNESNewtonTRSetTolerances() and
      SNESNewtonTRSetUpdateParameters() to programmatically set trust
      region parameters Deprecate SNESSetTrustRegionTolerance() in
      favor of SNESNewtonTRSetTolerances()
    + Add SNESResetCounters() to reset counters for linear iterations
      and function evaluations
  * TS:
    + Add Rosenbrock-W methods from :cite:`rang2015improved` with
      B_{PR} stability: TSROSWR34PRW, TSROSWR3PRL2, TSROSWRODASPR,
      and TSROSWRODASPR2
    + Add support for PETSC_DETERMINE as an argument to
      TSSetTolerances() to set the parameter back to its initial
      value when the object's type was set Deprecate PETSC_DEFAULT
      in favor of PETSC_CURRENT for  TSSetTolerances()
    + Add support for PETSC_DETERMINE as an argument to
      TSSetMaxSteps() and TSSetMaxTime()
    + Deprecate PETSC_DEFAULT in favor of PETSC_CURRENT for
      TSAdaptSetSafety()
    + Deprecate PETSC_DEFAULT in favor of PETSC_CURRENT for
      TSAdaptSetClip()
    + Deprecate PETSC_DEFAULT in favor of PETSC_CURRENT for
      TSAdaptSetStepLimits()
    + Add  TSGetStepResize()
    + Add  -ts_monitor_solution_vtk_interval to control the interval
      for dumping files
    + Add a new ARKIMEX solver for fast-slow systems that are
      partitioned component-wise and additively at the same time
    + Add TSRHSSplitSetIFunction(), TSRHSSplitSetIJacobian(),
      TSRHSSplitSetSNES(), TSRHSSplitGetSNES(),
      TSARKIMEXSetFastSlowSplit(), and TSARKIMEXGetFastSlowSplit()
      to support the new solver
  * TAO:
    + Add support for PETSC_DETERMINE as an argument to
      TaoSetTolerances() and TaoSetConstraintTolerances() to set
      the parameter back to its initial value when the object's
      type was set
    + Deprecate PETSC_DEFAULT in favor of PETSC_CURRENT for
      TaoSetTolerances() and TaoSetConstraintTolerances()
  * DM/DA:
    + Add DMGetSparseLocalize() and DMSetSparseLocalize()
    + Add DMGeomModelRegister(), DMGeomModelRegisterAll(),
      DMGeomModelRegisterDestroy(), DMSnapToGeomModel(), and
      DMSetSnapToGeomModel() to support registering geometric models
    + Add DMGetOutputSequenceLength()
    + Add an additional return vector to DMCreateMassMatrixLumped()
      to retrieve the local mass lumping
    + Add DMPlexMigrateGlobalToNaturalSF() modifies the NaturalSF to
      map from the SF's old global section to the new global section
  * DMPlex:
    + Add DMLabelGetValueBounds()
    + Add DMPlexOrientLabel()
    + Add an argument to DMPlexLabelCohesiveComplete() in order to
      change behavior at surface boundary Remove
      DMPlexSnapToGeomModel()
    + Add refinement argument to DMPlexCreateHexCylinderMesh()
    + Now DMPlexComputeBdIntegral() takes one function per field
    + Add DMPlexCreateEdgeNumbering()
    + Add DMPlexComputeL2FluxDiffVec() and
      DMPlexComputeL2FluxDiffVecLocal()
    + Add DMAdaptorSetType(), DMAdaptorGetType(), DMAdaptorRegister(),
      DMAdaptorRegisterAll(), and DMAdaptorRegisterDestroy()
    + Add DMAdaptorGetMixedSetupFunction() and
      DMAdaptorSetMixedSetupFunction()
    + Add DMPlexCreateCellNumbering()
    + Add DMPlexBuildFromCellSectionParallel() and
      DMPlexCreateFromCellSectionParallel()
    + Add -dm_plex_box_label to add "Face Sets" label with current
      "box" conventions
    + Add "Face Sets" label to simplex meshes using current "box"
      conventions Update PetscViewerExodusII object to cache variable
      names  for faster and  more robust look-ups
    + Add PetscViewerExodusIISetNodalVariable(),
      PetscViewerExodusIISetZonalVariable(),
      PetscViewerExodusIIGetNodalVariable(), and
      PetscViewerExodusIIGetZonalVariable() to set or get the number
      of variables in a file
    + Add PetscViewerExodusIISetNodalVariableName(),
      PetscViewerExodusIISetZonalVariableName(),
      PetscViewerExodusIIGetNodalVariableName(), and
      PetscViewerExodusIIGetZonalVariableName() to set or get a
      single variable name
    + Add PetscViewerExodusIISetNodalVariablesNames(),
      PetscViewerExodusIISetZonalVariablesNames(),
      PetscViewerExodusIIGetNodalVariablesNames(), and
      PetscViewerExodusIIGetZonalVariablesNames() to set or get all
      variable names at the same time (not available in Fortran)
    + Add degree bounds to DMCopyFields(), DMCopyDS(), PetscDSCopy(),
      and PetscDSSelectDiscretizations()
    + Add PetscFELimitDegree()
    + Add localizationHeight and sparseLocalize arguments to
      DMPlexCreateBoxMesh() for coordinate localization on periodic
      meshes
    + Add parallel CGNS reader, enabled by -dm_plex_cgns_parallel
    + Add CGNS function for VecLoad() of solutions in parallel (must
      be run with -dm_plex_cgns_parallel)
    + Add PetscViewerCGNSOpen() convenience function
    + Add PetscViewerCGNSGetSolutionTime(),
      PetscViewerCGNSGetSolutionName(),
      PetscViewerCGNSSetSolutionIndex(), and
      PetscViewerCGNSGetSolutionIndex()
    + Add DMPlexGetDepthStratumGlobalSize()
  * DT:
    + Add PetscDSSetIntegrationParameters() and
      PetscDSSetCellParameters()
  * Fortran:
    + Add PETSC_NULL_ENUM to be used instead of PETSC_NULL_INTEGER
      when a pointer to an enum is expected in a PETSc function call
    + Add PETSC_NULL_INTEGER_ARRAY, PETSC_NULL_SCALAR_ARRAY, and
      PETSC_NULL_REAL_ARRAY for use instead of PETSC_NULL_INTEGER,
      PETSC_NULL_SCALAR,  and PETSC_NULL_REAL when an array is
      expected in a PETSc function call
    + Add automatically generated interface definitions for most
      PETSc functions to detect illegal usage at compile time
    + Add PetscObjectIsNull() for users to check if a PETSc
      object is NULL
    + Change the PETSc Fortran API so that non-array values, v,
      passed to PETSc routines expecting arrays must be cast with
      [v] in the calling sequence

OBS-URL: https://build.opensuse.org/request/show/1235213
OBS-URL: https://build.opensuse.org/package/show/science/petsc?expand=0&rev=139
2025-01-07 18:42:31 +00:00
81f319d9a5 Accepting request 1229649 from home:badshah400:branches:science
Add necessary BuildRequires for hpc flavours to allow use of %requires_eq.

OBS-URL: https://build.opensuse.org/request/show/1229649
OBS-URL: https://build.opensuse.org/package/show/science/petsc?expand=0&rev=137
2024-12-10 08:57:23 +00:00
db4a427594 Accepting request 1189657 from home:AndreasStieger:branches:science
- fix missing libyaml requirement of -devel package boo#1228280

OBS-URL: https://build.opensuse.org/request/show/1189657
OBS-URL: https://build.opensuse.org/package/show/science/petsc?expand=0&rev=135
2024-07-29 07:00:29 +00:00
df1e853f29 Accepting request 1181550 from home:eeich:branches:science
- Update to version 3.21:
  - General:
    * Add single precision support for using HYPRE and MFEM
    * Require Fortran 2003 compiler with `GET_COMMAND_ARGUMENT()` support
      for building PETSc with Fortran bindings
  - Sys:
    * Add `PetscBench` an object class for managing benchmarks in PETSc
    * Deprecate `PetscVoidFunction`, `PetscVoidStarFunction`, and
      `PetscErrorCodeFunction` typedefs in favor of `PetscVoidFn` and
      `PetscErrorCodeFn`.
    * Add `PetscOptionsBoundedReal()` and `PetscOptionsRangeReal()`.
    * Rename Petsc stream types to `PETSC_STREAM_DEFAULT`,
      `PETSC_STREAM_NONBLOCKING`, `PETSC_STREAM_DEFAULT`_WITH_BARRIER` and
      `PETSC_STREAM_NONBLOCKING_WITH_BARRIER`. The root device context uses
      `PETSC_STREAM_DEFAULT` by default.
  - PetscViewer:
    * Change `PetscViewerRestoreSubViewer()` to no longer need a call to
      `PetscViewerFlush()` after it.
    * Introduce `PetscOptionsRestoreViewer()` that must be called after
      `PetscOptionsGetViewer()` and `PetscOptionsGetViewers()` to ensure
      thread safety.
    * Add `PetscViewerASCIIWORLDSetFileUnit()`.
  - VecScatter / PetscSF:
     * Add MPI-4.0 persistent neighborhood collectives support. Use
       `-sf_neighbor_persistent` along with `-sf_type` neighbor to enable it.
     * Add `PetscSFCreateStridedSF()` to communicate strided blocks of data/
  - Vec:
    * Add `VecGhostGetGhostIS()` to get the ghost indices of a ghosted vector.
    * Add `-vec_mdot_use_gemv` to let `VecMDot()`, `VecMTDot()` use BLAS2
      `gemv()` instead of custom unrolled kernel. Default is on.

OBS-URL: https://build.opensuse.org/request/show/1181550
OBS-URL: https://build.opensuse.org/package/show/science/petsc?expand=0&rev=133
2024-06-19 16:43:14 +00:00
f9da9db1cd Accepting request 1130579 from home:badshah400:branches:science
- Make a symlink to the real pkgconfig dir (for example, in an
  installed system) for package's absurdly located pkgconfig file.
  This is a minimal workaround to boo#1217751, I guess.
- Cosmetic touch-ups.

OBS-URL: https://build.opensuse.org/request/show/1130579
OBS-URL: https://build.opensuse.org/package/show/science/petsc?expand=0&rev=131
2023-12-24 08:24:41 +00:00
27dbfcddc0 Accepting request 1119730 from home:eeich:branches:science
- Disable HPC flavors on i586

OBS-URL: https://build.opensuse.org/request/show/1119730
OBS-URL: https://build.opensuse.org/package/show/science/petsc?expand=0&rev=128
2023-10-23 20:37:18 +00:00
b6ee58d951 Accepting request 1119631 from home:NMorey:branches:science
- Drop support for obsolete openmpi[123]
- Prepare support for openmpi5

OBS-URL: https://build.opensuse.org/request/show/1119631
OBS-URL: https://build.opensuse.org/package/show/science/petsc?expand=0&rev=127
2023-10-23 19:03:47 +00:00
af374f2616 Accepting request 1073669 from home:StefanBruens:branches:science
- Update to version 3.18.5.
  * Too many changes to list, for details see 
    https://petsc.org/release/docs/changes/
- Fix broken usage of MAKEFLAGS, causing build failures with
  gmake >= 4.4.1.

OBS-URL: https://build.opensuse.org/request/show/1073669
OBS-URL: https://build.opensuse.org/package/show/science/petsc?expand=0&rev=125
2023-03-23 13:17:08 +00:00
ebcf5edbfc Accepting request 1065848 from home:StefanBruens:branches:science
- Remove incorrect library symlink with major version only.

OBS-URL: https://build.opensuse.org/request/show/1065848
OBS-URL: https://build.opensuse.org/package/show/science/petsc?expand=0&rev=123
2023-02-15 05:40:05 +00:00
3392ead19c Accepting request 1063431 from home:StefanBruens:branches:science
- Update to version 3.18.4.
  * Too many changes to list, for details see 
    https://petsc.org/release/docs/changes/
- Use Python3 also on Leap/SLE, Python 2.7 is no longer supported
- Clean up spec file
- Remove unreproducible build host core count from petscvariables
  (NPMAX, MAKE_NP etc).
- Remove doc subpackage, documentation is no longer included in
  upstream tarball.

OBS-URL: https://build.opensuse.org/request/show/1063431
OBS-URL: https://build.opensuse.org/package/show/science/petsc?expand=0&rev=122
2023-02-13 18:11:58 +00:00
73bdb6d9d5 Accepting request 989690 from home:StefanBruens:branches:science
- Fix library package name for non-HPC flavors.
- Remove openmpi1 for non-HPC.
- Correct valgrind-devel BuildRequires.
- Add rpmlintrc to ignore some empty files in examples

OBS-URL: https://build.opensuse.org/request/show/989690
OBS-URL: https://build.opensuse.org/package/show/science/petsc?expand=0&rev=120
2022-08-01 17:20:45 +00:00
7e1539b4d5 Accepting request 955472 from home:eeich:branches:science
- Remove dependency on librt for libsuitparse to make the non-HPC
  build on Factory again.

OBS-URL: https://build.opensuse.org/request/show/955472
OBS-URL: https://build.opensuse.org/package/show/science/petsc?expand=0&rev=117
2022-02-16 19:38:23 +00:00
02512c3973 Accepting request 955409 from home:eeich:branches:science
- Fix HPC module settings (bsc#1195782).

OBS-URL: https://build.opensuse.org/request/show/955409
OBS-URL: https://build.opensuse.org/package/show/science/petsc?expand=0&rev=116
2022-02-16 15:45:13 +00:00
933366773d Accepting request 881044 from home:eeich:branches:science
- Update to version 3.14.5.
  * Documentation & man page fixes, removal of non-existing functions.
  * CPARDISO: stick to OpenMPI BLACS when needed
  * bugfix for MatMatMultSymbolic_MPIAIJ_MPIDense() when Bbn1 = 0.
    Bb (column block size) zero lead to infinite loop in
    MatMatMultNumeric_MPIAIJ_MPIDense() with n=0.
  * petscviewer: fix the fortran bindings of XXXViewFromOptions
    when called with obj=PETSC_NULL_XXX.
  * PetscOptionsPrefixPush: Accept numbers if the stack is not
    empty.
  * PetscOptionsClearValue: Also clear 'help_intro' slot.
  * PetscOptionsDestroyDefault: Fix possible NULL-dereference.
  * PetscOptionsUsed: Fix for case-insensitive string comparison.
  * Do not use MPI_Bcast() on a single rank - This allows direct
    reading  of much larger files, in, for example, MatLoad_SeqAIJ_Binary.
  * PCHPDDM: fix for KSPLSQR.
  * DMPlexVTKWriteAll_VTU: numerous bugfixes.
  * MatBAIJ: FIx specialization for size 9.

OBS-URL: https://build.opensuse.org/request/show/881044
OBS-URL: https://build.opensuse.org/package/show/science/petsc?expand=0&rev=113
2021-03-24 13:56:43 +00:00
0e93e0604d Accepting request 875002 from home:mslacken:branches:science
- Updated to version 3.14.4 (jsc#SLE-14959)
  * versionToTuple: ignore leading strings in package versions.
      i.e 5.3.3consortium -> 5.3.3
  * Add error checks for integer overflow for
    MatSeqXAIJSetPreallocation when the user provides nnz[].
    Otherwise PetscMalloc() can produce error messages with requests to
    absurds amount of memory.
    Improve the error message for PetscIntMultError() and other casting
    routines and add more seealso entries to the manual pages.
  * Update dmlocalts.c to prevent zeroing out of locX_t after being computed
    in TSComputeIJacobian_DMLocal.
  * nargs.Arg: Remove interactiveness; provide useful error when key is not
    found.
  * DMPlexLandau: fix implicit conversion.
  * Allow users to mistaken use openmpi or mpich when setting mpi or mpi-dir
    and consistently use local variable 'name'
  * Consume -help in PetscOptionsSetValue() so it can be set from RC file etc.
  * Enable search patterns to have 'src*' at start.
  * Fix Matlab int32 to match changed changes in PETSc data types.
  * Generate error instead of crashing when estimating eigenvalues for
    Chebyshev, no right hand side vector is available and the user requested
    to not use a noisy right hand side.
  * Fix pcmgsetlevels() for Fortran to properly convert the C MPI communictors
    to Fortran.
  * Fix PCMGSetLevels_MG() to support the use of MPI_COMM_NULL for
    communicators that that live on a subset of the orginal communicator.
  *  Add additional documentation material to PCMGSetLevels() explaining how
     one must handle the restriction and interpolation operations that move
     between different levels which have a different number of MPI ranks.
  * Call PetscCUDAInitializeCheck() in

OBS-URL: https://build.opensuse.org/request/show/875002
OBS-URL: https://build.opensuse.org/package/show/science/petsc?expand=0&rev=111
2021-02-25 10:08:40 +00:00
6ac7529286 Accepting request 869850 from home:eeich:branches:science
- Add build support for gcc10 to HPC build (bsc#1174439).
- Add openmpi4 flavors.

OBS-URL: https://build.opensuse.org/request/show/869850
OBS-URL: https://build.opensuse.org/package/show/science/petsc?expand=0&rev=109
2021-02-05 21:51:08 +00:00
0b2b2acbbe - Make sure, doc package is built for SLE (bsc#1173269).
OBS-URL: https://build.opensuse.org/package/show/science/petsc?expand=0&rev=107
2021-02-01 08:27:41 +00:00
43e1f3655d Accepting request 867621 from home:eeich:branches:science
- Change 'Requires:' to other HPC packages to %requires_eq to depend
  on the exact version. This should take care of HPC packages ignoring
  proper ABI versioning.

OBS-URL: https://build.opensuse.org/request/show/867621
OBS-URL: https://build.opensuse.org/package/show/science/petsc?expand=0&rev=105
2021-01-29 08:15:21 +00:00
Ana Guerrero
0f99f933c8 Accepting request 846446 from home:anag:branches:science
- Update to version 3.14.1
  * https://www.mcs.anl.gov/petsc/documentation/changes/314.html
- Refresh patches

OBS-URL: https://build.opensuse.org/request/show/846446
OBS-URL: https://build.opensuse.org/package/show/science/petsc?expand=0&rev=103
2020-11-06 12:52:19 +00:00
c295f9055e Accepting request 761940 from home:StefanBruens:branches:science
- Force use of python3 on Tumbleweed. As the python2 executable was
  also set in petsc's configuration, dependent packages no longer
  depend on python2.
- Fix she-bangs in python scripts
- Only require python{2,3}-base packages instead of full packages.

OBS-URL: https://build.opensuse.org/request/show/761940
OBS-URL: https://build.opensuse.org/package/show/science/petsc?expand=0&rev=101
2020-01-09 17:48:37 +00:00
4bfd72867e - Remove unneeded dependency from HPC devel package.
OBS-URL: https://build.opensuse.org/package/show/science/petsc?expand=0&rev=99
2019-12-11 17:35:33 +00:00
3055a0df25 - Add HPC builds for gcc8 & gcc 9 (jsc#SLE-7766 & jsc#SLE-8604).
OBS-URL: https://build.opensuse.org/package/show/science/petsc?expand=0&rev=97
2019-12-10 21:33:54 +00:00
25be05c794 Accepting request 753309 from home:eeich:branches:science
- Update to version 3.12.2 (jsc#SLE-8505)
  * https://www.mcs.anl.gov/petsc/documentation/changes/312.html
- Remove petsc-3.3-p2-fix-shared-libs-sonames.patch
  link created directly in %install section
- Remove petsc-3.3-p2-dont-check-for-option-mistakes.patch
  not needed.
- Remove petsc-3.3-fix-error-detection-in-makefile.patch
  not needed.
- Add non-HPC build with openmpi3
- Add HPC builds for gcc8 & gcc 9 (jsc#SLE-7766 & jsc#SLE-8609).
- Disable openmpi1 builds for SLE/Leap > 15.1.
- Enable openmpi3 builds for Leap and SLE > 15.1 (jsc#SLE-7773).

OBS-URL: https://build.opensuse.org/request/show/753309
OBS-URL: https://build.opensuse.org/package/show/science/petsc?expand=0&rev=94
2019-12-04 07:06:10 +00:00
Ana Guerrero
5fe61db39e Accepting request 751477 from home:StefanBruens:branches:science
- Reflect renaming of openmpi packages to openmpi1 in Tumbleweed,
  fixes unresolvable packages.
- Fix copy'n'paste error, mpi_vers vs. mpi_ver
- Add non-HPC openmpi2 flavor.

OBS-URL: https://build.opensuse.org/request/show/751477
OBS-URL: https://build.opensuse.org/package/show/science/petsc?expand=0&rev=92
2019-11-28 10:36:07 +00:00
Ana Guerrero
22ede199ee Add Jira feature ID
OBS-URL: https://build.opensuse.org/package/show/science/petsc?expand=0&rev=90
2019-09-27 14:39:45 +00:00
Ana Guerrero
24957e4346 Accepting request 725356 from home:anag:branches:science
- Update to version 3.11.3
  - https://www.mcs.anl.gov/petsc/documentation/changes/311.html
  - Binaries have changed path from bin/ to lib/petsc/bin/
- Patches removed, merged by upstream
  * Python-Fix-a-number-of-scripts-to-by-Python-3-compliant.patch
  * petsc-fix-nonmpi.patch
- Patches refreshed
  * petsc-3.3-p2-fix-shared-libs-sonames.patch
  * petsc-3.3-p2-no-rpath.patch
  * petsc-3.3-p2-dont-check-for-option-mistakes.patch
  * petsc-3.3-fix-error-detection-in-makefile.patch
  * petsc-3.7-fix-pastix-detection.patch
- Set -fPIC also on x86_64

OBS-URL: https://build.opensuse.org/request/show/725356
OBS-URL: https://build.opensuse.org/package/show/science/petsc?expand=0&rev=88
2019-08-22 15:19:44 +00:00
a990303cc1 - Upped memory constraints to 6G for non-ppc systems as well,
leaving the special ppc treatment in place in case we need to up it
  some more there.

OBS-URL: https://build.opensuse.org/package/show/science/petsc?expand=0&rev=86
2019-07-19 16:17:20 +00:00
5844df210c Accepting request 716001 from home:michel_mno:branches:science
- update _constraints for PowerPC more than 4G memory
- Add BuildRequires libopenblas-gnu-hpc >=  0.3.6 for hpc to  avoid
  to build when openblas library not available (for ppc64)

OBS-URL: https://build.opensuse.org/request/show/716001
OBS-URL: https://build.opensuse.org/package/show/science/petsc?expand=0&rev=85
2019-07-17 08:10:45 +00:00
25a384fc06 Accepting request 688858 from home:StefanBruens:branches:science
- Disable pastix also in openmpi flavor, same as for serial and HPC flavors.
  Pastix is only built with openmpi, and not available in Factory.
- Fix building non-MPI flavors of packages depending on petsc
  Add petsc-fix-nonmpi.patch
- Do not move headers to /usr/include and symlink, causes problems with
  -isystem

OBS-URL: https://build.opensuse.org/request/show/688858
OBS-URL: https://build.opensuse.org/package/show/science/petsc?expand=0&rev=83
2019-03-26 18:14:49 +00:00
015e93101c Accepting request 684804 from home:StefanBruens:branches:science
- Fix spec for non-HPC, reenable serial and non-HPC openmpi build.
- Disable HYPRE for non-HPC, same as for HPC.

OBS-URL: https://build.opensuse.org/request/show/684804
OBS-URL: https://build.opensuse.org/package/show/science/petsc?expand=0&rev=82
2019-03-15 16:20:09 +00:00
a2676994fd Accepting request 674840 from home:eeich:branches:science
- Consolidate use of openmpi1, openmpi2, openmpi3.
- Do not build non-HPC on SLE.

OBS-URL: https://build.opensuse.org/request/show/674840
OBS-URL: https://build.opensuse.org/package/show/science/petsc?expand=0&rev=81
2019-02-14 06:49:47 +00:00
Ismail Dönmez
5e5284e1a1 Accepting request 601899 from home:Guillaume_G:branches:openSUSE:Factory:ARM
- Add _constraints to avoid OOM errors

OBS-URL: https://build.opensuse.org/request/show/601899
OBS-URL: https://build.opensuse.org/package/show/science/petsc?expand=0&rev=79
2018-05-16 08:19:59 +00:00
5acdd5227a Accepting request 602639 from home:eeich:branches:science
- (Temporarily) disable fpr S390* as a check test for netcdf fails
  currently on BE (bsc#1091474).

OBS-URL: https://build.opensuse.org/request/show/602639
OBS-URL: https://build.opensuse.org/package/show/science/petsc?expand=0&rev=77
2018-04-30 20:58:24 +00:00
027b90fbfd - Do not require 'Modules' for HPC build: seetings from
/etc/profile.d/lmod.[c]sh will be overwritten by
  /etc/profile.d/modules.[c]sh installed by Modules
  (bsc#1089865).

OBS-URL: https://build.opensuse.org/package/show/science/petsc?expand=0&rev=75
2018-04-17 13:21:07 +00:00
732502b1d0 - Do not require 'Modules' for HPC build: it will overwrite
/etc/profile.d/modules.sh installed by lua-lmod (bsc#1089865).

OBS-URL: https://build.opensuse.org/package/show/science/petsc?expand=0&rev=74
2018-04-17 12:57:50 +00:00
592437c48e - Convert doc package build to noarch. This will hopefully avoid
spurious build errors on SLE-12.

OBS-URL: https://build.opensuse.org/package/show/science/petsc?expand=0&rev=72
2018-04-01 19:13:26 +00:00
a4a1f63af8 Accepting request 591709 from home:StefanBruens:branches:openSUSE:Factory:ARM
- Set '-fPIC' also on aarch64

OBS-URL: https://build.opensuse.org/request/show/591709
OBS-URL: https://build.opensuse.org/package/show/science/petsc?expand=0&rev=71
2018-04-01 10:59:01 +00:00
43e68f75e5 Accepting request 589189 from home:oertel:branches:science
- use "-fPIC" also on s390, like on ppc64 (bsc#1086008)

OBS-URL: https://build.opensuse.org/request/show/589189
OBS-URL: https://build.opensuse.org/package/show/science/petsc?expand=0&rev=70
2018-03-27 15:31:53 +00:00
1a310b25cf Accepting request 591603 from home:eeich:branches:science
- Reenable flavor 'serial' to build the doc package only
  (bsc#1087050).
  Note: for this flavor nothing else gets built: once the
  missing dependencies have been fixed, rearrange the 
  #%if 0%{?makedoc:1} ... %endif.

OBS-URL: https://build.opensuse.org/request/show/591603
OBS-URL: https://build.opensuse.org/package/show/science/petsc?expand=0&rev=69
2018-03-27 12:39:09 +00:00
9956dd0d4d - Don't build the serial flavor as the build presently breaks
everywhere (bsc#1084677).

OBS-URL: https://build.opensuse.org/package/show/science/petsc?expand=0&rev=67
2018-03-09 12:47:21 +00:00
165973c6c7 - Don't build the serial flavor for SLE as it only builds in the
devel project (bsc#1084677).

OBS-URL: https://build.opensuse.org/package/show/science/petsc?expand=0&rev=66
2018-03-09 12:37:45 +00:00
078887870f - Python-Fix-a-number-of-scripts-to-by-Python-3-compliant.patch:
Fix python scripts - convert to Python 3 (bsc#1082209).

OBS-URL: https://build.opensuse.org/package/show/science/petsc?expand=0&rev=65
2018-03-04 14:54:11 +00:00
9b611159d2 Accepting request 582384 from home:eeich:python
- Fix python scripts - convert to Python 3 (bsc#1082209).
- Restructure package: factor out SAWs stuff. We cannot
  support this as SAWs itself isn't available for SUSE.
- Move python files that are not stand-alone out of the
  bin directory.
- Fix permissions in bin and other directories.
- Removed some unwanted scripts:
  rules - make rules
  sendToJenkins - this should probably be modified to print an error message
  uncrustify.cfg - used by 'rules'
- Removed win32fe: DLLs for Windows
- Set '-fPIC' on ppc64.

OBS-URL: https://build.opensuse.org/request/show/582384
OBS-URL: https://build.opensuse.org/package/show/science/petsc?expand=0&rev=64
2018-03-04 13:51:28 +00:00
1271c74547 Accepting request 579204 from home:eeich:branches:science
- Update to version 3.8.3:
  http://www.mcs.anl.gov/petsc/documentation/changes/37.html
  (FATE#325333).

OBS-URL: https://build.opensuse.org/request/show/579204
OBS-URL: https://build.opensuse.org/package/show/science/petsc?expand=0&rev=62
2018-02-22 21:29:34 +00:00
d2108b7883 - Since the OpenBLAS build was fixed, reenable scalapack
on s390 (bsc#1079513).
- Fix build on ppc64le (bsc#1080380).

OBS-URL: https://build.opensuse.org/package/show/science/petsc?expand=0&rev=58
2018-02-09 20:55:09 +00:00