ngsolve 6.2.2503__cp312-cp312-macosx_10_15_universal2.whl → 6.2.2504.post12.dev0__cp312-cp312-macosx_10_15_universal2.whl

This diff represents the content of publicly available package versions that have been released to one of the supported registries. The information contained in this diff is provided for informational purposes only and reflects changes between package versions as they appear in their respective public registries.

Potentially problematic release.


This version of ngsolve might be problematic. Click here for more details.

Files changed (67) hide show
  1. netgen/include/h1amg.hpp +62 -2
  2. netgen/include/integrator.hpp +4 -16
  3. netgen/include/mp_coefficient.hpp +140 -0
  4. netgen/include/mptools.hpp +42 -161
  5. netgen/include/potentialtools.hpp +2 -0
  6. netgen/include/preconditioner.hpp +21 -21
  7. netgen/include/sparsematrix_dyn.hpp +6 -7
  8. netgen/include/special_matrix.hpp +2 -0
  9. netgen/include/symbolicintegrator.hpp +2 -1
  10. netgen/libngbla.dylib +0 -0
  11. netgen/libngcomp.dylib +0 -0
  12. netgen/libngfem.dylib +0 -0
  13. netgen/libngla.dylib +0 -0
  14. netgen/libngsbem.dylib +0 -0
  15. netgen/libngstd.dylib +0 -0
  16. ngsolve/__init__.py +1 -0
  17. ngsolve/__init__.pyi +4 -2
  18. ngsolve/bla.pyi +8 -0
  19. ngsolve/cmake/NGSolveConfig.cmake +5 -5
  20. ngsolve/comp/__init__.pyi +35 -19
  21. ngsolve/config/__init__.pyi +7 -7
  22. ngsolve/config/config.py +6 -6
  23. ngsolve/config/config.pyi +7 -7
  24. ngsolve/fem.pyi +6 -0
  25. ngsolve/preconditioners.py +1 -0
  26. ngsolve/preconditioners.pyi +2 -1
  27. ngsolve/solve_implementation.py +146 -0
  28. ngsolve/solve_implementation.pyi +42 -0
  29. ngsolve/utils.pyi +2 -1
  30. {ngsolve-6.2.2503.dist-info → ngsolve-6.2.2504.post12.dev0.dist-info}/METADATA +2 -2
  31. {ngsolve-6.2.2503.dist-info → ngsolve-6.2.2504.post12.dev0.dist-info}/RECORD +67 -64
  32. {ngsolve-6.2.2503.data → ngsolve-6.2.2504.post12.dev0.data}/data/Netgen.icns +0 -0
  33. {ngsolve-6.2.2503.data → ngsolve-6.2.2504.post12.dev0.data}/data/bin/ngscxx +0 -0
  34. {ngsolve-6.2.2503.data → ngsolve-6.2.2504.post12.dev0.data}/data/bin/ngsld +0 -0
  35. {ngsolve-6.2.2503.data → ngsolve-6.2.2504.post12.dev0.data}/data/bin/ngsolve.tcl +0 -0
  36. {ngsolve-6.2.2503.data → ngsolve-6.2.2504.post12.dev0.data}/data/bin/ngspy +0 -0
  37. {ngsolve-6.2.2503.data → ngsolve-6.2.2504.post12.dev0.data}/data/share/ngsolve/beam.geo +0 -0
  38. {ngsolve-6.2.2503.data → ngsolve-6.2.2504.post12.dev0.data}/data/share/ngsolve/beam.vol +0 -0
  39. {ngsolve-6.2.2503.data → ngsolve-6.2.2504.post12.dev0.data}/data/share/ngsolve/chip.in2d +0 -0
  40. {ngsolve-6.2.2503.data → ngsolve-6.2.2504.post12.dev0.data}/data/share/ngsolve/chip.vol +0 -0
  41. {ngsolve-6.2.2503.data → ngsolve-6.2.2504.post12.dev0.data}/data/share/ngsolve/coil.geo +0 -0
  42. {ngsolve-6.2.2503.data → ngsolve-6.2.2504.post12.dev0.data}/data/share/ngsolve/coil.vol +0 -0
  43. {ngsolve-6.2.2503.data → ngsolve-6.2.2504.post12.dev0.data}/data/share/ngsolve/coilshield.geo +0 -0
  44. {ngsolve-6.2.2503.data → ngsolve-6.2.2504.post12.dev0.data}/data/share/ngsolve/coilshield.vol +0 -0
  45. {ngsolve-6.2.2503.data → ngsolve-6.2.2504.post12.dev0.data}/data/share/ngsolve/cube.geo +0 -0
  46. {ngsolve-6.2.2503.data → ngsolve-6.2.2504.post12.dev0.data}/data/share/ngsolve/cube.vol +0 -0
  47. {ngsolve-6.2.2503.data → ngsolve-6.2.2504.post12.dev0.data}/data/share/ngsolve/d10_DGdoubleglazing.pde +0 -0
  48. {ngsolve-6.2.2503.data → ngsolve-6.2.2504.post12.dev0.data}/data/share/ngsolve/d11_chip_nitsche.pde +0 -0
  49. {ngsolve-6.2.2503.data → ngsolve-6.2.2504.post12.dev0.data}/data/share/ngsolve/d1_square.pde +0 -0
  50. {ngsolve-6.2.2503.data → ngsolve-6.2.2504.post12.dev0.data}/data/share/ngsolve/d2_chip.pde +0 -0
  51. {ngsolve-6.2.2503.data → ngsolve-6.2.2504.post12.dev0.data}/data/share/ngsolve/d3_helmholtz.pde +0 -0
  52. {ngsolve-6.2.2503.data → ngsolve-6.2.2504.post12.dev0.data}/data/share/ngsolve/d4_cube.pde +0 -0
  53. {ngsolve-6.2.2503.data → ngsolve-6.2.2504.post12.dev0.data}/data/share/ngsolve/d5_beam.pde +0 -0
  54. {ngsolve-6.2.2503.data → ngsolve-6.2.2504.post12.dev0.data}/data/share/ngsolve/d6_shaft.pde +0 -0
  55. {ngsolve-6.2.2503.data → ngsolve-6.2.2504.post12.dev0.data}/data/share/ngsolve/d7_coil.pde +0 -0
  56. {ngsolve-6.2.2503.data → ngsolve-6.2.2504.post12.dev0.data}/data/share/ngsolve/d8_coilshield.pde +0 -0
  57. {ngsolve-6.2.2503.data → ngsolve-6.2.2504.post12.dev0.data}/data/share/ngsolve/d9_hybridDG.pde +0 -0
  58. {ngsolve-6.2.2503.data → ngsolve-6.2.2504.post12.dev0.data}/data/share/ngsolve/doubleglazing.in2d +0 -0
  59. {ngsolve-6.2.2503.data → ngsolve-6.2.2504.post12.dev0.data}/data/share/ngsolve/doubleglazing.vol +0 -0
  60. {ngsolve-6.2.2503.data → ngsolve-6.2.2504.post12.dev0.data}/data/share/ngsolve/piezo2d40round4.vol.gz +0 -0
  61. {ngsolve-6.2.2503.data → ngsolve-6.2.2504.post12.dev0.data}/data/share/ngsolve/shaft.geo +0 -0
  62. {ngsolve-6.2.2503.data → ngsolve-6.2.2504.post12.dev0.data}/data/share/ngsolve/shaft.vol +0 -0
  63. {ngsolve-6.2.2503.data → ngsolve-6.2.2504.post12.dev0.data}/data/share/ngsolve/square.in2d +0 -0
  64. {ngsolve-6.2.2503.data → ngsolve-6.2.2504.post12.dev0.data}/data/share/ngsolve/square.vol +0 -0
  65. {ngsolve-6.2.2503.dist-info → ngsolve-6.2.2504.post12.dev0.dist-info}/LICENSE +0 -0
  66. {ngsolve-6.2.2503.dist-info → ngsolve-6.2.2504.post12.dev0.dist-info}/WHEEL +0 -0
  67. {ngsolve-6.2.2503.dist-info → ngsolve-6.2.2504.post12.dev0.dist-info}/top_level.txt +0 -0
@@ -99,12 +99,12 @@ namespace ngcomp
99
99
  virtual void InitLevel (shared_ptr<BitArray> freedofs = NULL) { ; }
100
100
  virtual void FinalizeLevel (const ngla::BaseMatrix * mat = NULL) { ; }
101
101
  virtual void AddElementMatrix (FlatArray<int> dnums,
102
- const FlatMatrix<double> & elmat,
102
+ FlatMatrix<double> elmat,
103
103
  ElementId ei,
104
104
  LocalHeap & lh) { ; }
105
105
 
106
106
  virtual void AddElementMatrix (FlatArray<int> dnums,
107
- const FlatMatrix<Complex> & elmat,
107
+ FlatMatrix<Complex> elmat,
108
108
  ElementId ei,
109
109
  LocalHeap & lh) { ; }
110
110
 
@@ -186,12 +186,12 @@ namespace ngcomp
186
186
  static DocInfo GetDocu ();
187
187
 
188
188
  ///
189
- virtual bool IsComplex() const { return jacobi->IsComplex(); }
189
+ virtual bool IsComplex() const override { return jacobi->IsComplex(); }
190
190
 
191
191
  ///
192
- virtual void FinalizeLevel (const BaseMatrix * mat);
192
+ virtual void FinalizeLevel (const BaseMatrix * mat) override;
193
193
 
194
- virtual void Update ()
194
+ virtual void Update () override
195
195
  {
196
196
  if (GetTimeStamp() < bfa->GetTimeStamp())
197
197
  FinalizeLevel (&bfa->GetMatrix());
@@ -201,14 +201,14 @@ namespace ngcomp
201
201
 
202
202
 
203
203
  ///
204
- virtual const BaseMatrix & GetMatrix() const
204
+ virtual const BaseMatrix & GetMatrix() const override
205
205
  {
206
206
  if (!jacobi)
207
207
  ThrowPreconditionerNotReady();
208
208
  return *jacobi;
209
209
  }
210
210
 
211
- virtual shared_ptr<BaseMatrix> GetMatrixPtr()
211
+ virtual shared_ptr<BaseMatrix> GetMatrixPtr() override
212
212
  {
213
213
  if (!jacobi)
214
214
  ThrowPreconditionerNotReady();
@@ -216,12 +216,12 @@ namespace ngcomp
216
216
  }
217
217
 
218
218
  ///
219
- virtual const BaseMatrix & GetAMatrix() const
219
+ virtual const BaseMatrix & GetAMatrix() const override
220
220
  {
221
221
  return bfa->GetMatrix();
222
222
  }
223
223
  ///
224
- virtual const char * ClassName() const
224
+ virtual const char * ClassName() const override
225
225
  { return "Local Preconditioner"; }
226
226
  void LocPrecTest () const;
227
227
  };
@@ -258,29 +258,29 @@ namespace ngcomp
258
258
  ; // delete pre;
259
259
  }
260
260
 
261
- virtual void InitLevel (shared_ptr<BitArray> _freedofs);
261
+ virtual void InitLevel (shared_ptr<BitArray> _freedofs) override;
262
262
 
263
- virtual void FinalizeLevel (const BaseMatrix *);
263
+ virtual void FinalizeLevel (const BaseMatrix *) override;
264
264
  virtual void AddElementMatrix (FlatArray<int> dnums,
265
- const FlatMatrix<SCAL> & elmat,
265
+ FlatMatrix<SCAL> elmat,
266
266
  ElementId id,
267
- LocalHeap & lh);
267
+ LocalHeap & lh) override;
268
268
 
269
- virtual void Update ()
269
+ virtual void Update () override
270
270
  {
271
271
  if (timestamp < bfa->GetTimeStamp())
272
272
  throw Exception("A BDDC preconditioner must be defined before assembling");
273
273
  }
274
274
 
275
- virtual const BaseMatrix & GetAMatrix() const
275
+ virtual const BaseMatrix & GetAMatrix() const override
276
276
  {
277
277
  return bfa->GetMatrix();
278
278
  }
279
279
 
280
- virtual const BaseMatrix & GetMatrix() const;
281
- virtual shared_ptr<BaseMatrix> GetMatrixPtr();
280
+ virtual const BaseMatrix & GetMatrix() const override;
281
+ virtual shared_ptr<BaseMatrix> GetMatrixPtr() override;
282
282
 
283
- virtual void CleanUpLevel ()
283
+ virtual void CleanUpLevel () override
284
284
  {
285
285
  /*
286
286
  delete pre;
@@ -290,10 +290,10 @@ namespace ngcomp
290
290
  }
291
291
 
292
292
 
293
- virtual void Mult (const BaseVector & x, BaseVector & y) const;
294
- virtual void MultAdd (double s, const BaseVector & x, BaseVector & y) const;
293
+ virtual void Mult (const BaseVector & x, BaseVector & y) const override;
294
+ virtual void MultAdd (double s, const BaseVector & x, BaseVector & y) const override;
295
295
 
296
- virtual const char * ClassName() const
296
+ virtual const char * ClassName() const override
297
297
  { return "BDDC Preconditioner"; }
298
298
  };
299
299
 
@@ -42,20 +42,19 @@ namespace ngla
42
42
  fm = matvec(i);
43
43
  }
44
44
  }
45
-
45
+
46
46
  virtual int VHeight() const override { return size; }
47
47
  virtual int VWidth() const override { return width; }
48
-
48
+
49
49
  virtual void Mult (const BaseVector & x, BaseVector & y) const override;
50
50
  virtual void MultAdd (double s, const BaseVector & x, BaseVector & y) const override;
51
-
51
+
52
52
  AutoVector CreateRowVector() const override
53
- { throw Exception("CreateRowVector not implemented for SparseMatrixDynamic!"); }
53
+ { throw make_unique<VVector<TSCAL>> (VWidth()); }
54
54
  AutoVector CreateColVector() const override
55
- { throw Exception("CreateColVector not implemented for SparseMatrixDynamic!"); }
56
-
55
+ { throw make_unique<VVector<TSCAL>> (VHeight()); }
56
+
57
57
  virtual tuple<int,int> EntrySizes() const override { return { bh, bw }; }
58
-
59
58
  };
60
59
 
61
60
 
@@ -182,6 +182,8 @@ namespace ngla
182
182
 
183
183
  virtual void MultAdd (double s, const BaseVector & x, BaseVector & y) const override;
184
184
  virtual void MultTransAdd (double s, const BaseVector & x, BaseVector & y) const override;
185
+
186
+ virtual shared_ptr<BaseSparseMatrix> CreateSparseMatrix() const override;
185
187
  };
186
188
 
187
189
 
@@ -604,6 +604,7 @@ public:
604
604
 
605
605
  class SymbolicFacetLinearFormIntegrator : public FacetLinearFormIntegrator
606
606
  {
607
+ protected:
607
608
  shared_ptr<CoefficientFunction> cf;
608
609
  Array<ProxyFunction*> proxies;
609
610
  Array<CoefficientFunction*> cache_cfs;
@@ -614,7 +615,7 @@ public:
614
615
  SIMD_IntegrationRule simd_ir; // if non-empty use this integration-rule
615
616
 
616
617
  public:
617
- SymbolicFacetLinearFormIntegrator (shared_ptr<CoefficientFunction> acf, VorB avb);
618
+ NGS_DLL_HEADER SymbolicFacetLinearFormIntegrator (shared_ptr<CoefficientFunction> acf, VorB avb);
618
619
 
619
620
  virtual VorB VB() const override { return vb; }
620
621
  virtual bool BoundaryForm() const override { return vb == BND; }
netgen/libngbla.dylib CHANGED
Binary file
netgen/libngcomp.dylib CHANGED
Binary file
netgen/libngfem.dylib CHANGED
Binary file
netgen/libngla.dylib CHANGED
Binary file
netgen/libngsbem.dylib CHANGED
Binary file
netgen/libngstd.dylib CHANGED
Binary file
ngsolve/__init__.py CHANGED
@@ -75,6 +75,7 @@ from .utils import x, y, z, dx, ds, grad, Grad, curl, div, Deviator, PyId, PyTra
75
75
  from . import solvers
76
76
  from . import preconditioners
77
77
  from . import timestepping
78
+ from .solve_implementation import Solve
78
79
 
79
80
  try:
80
81
  from netgen.occ import unit_square, unit_cube
ngsolve/__init__.pyi CHANGED
@@ -147,6 +147,7 @@ from ngsolve.la import QMRSolver
147
147
  from ngsolve.ngstd import IntRange
148
148
  from ngsolve.solve import Draw
149
149
  from ngsolve.solve import SetVisualization
150
+ from ngsolve.solve_implementation.Application import Solve
150
151
  from ngsolve.timing import Timing
151
152
  from ngsolve.utils import Deviator
152
153
  from ngsolve.utils import Grad
@@ -185,11 +186,12 @@ from . import ngstd
185
186
  from . import nonlinearsolvers
186
187
  from . import preconditioners
187
188
  from . import solve
189
+ from . import solve_implementation
188
190
  from . import solvers
189
191
  from . import timestepping
190
192
  from . import timing
191
193
  from . import utils
192
- __all__ = ['APhiHCurlAMG', 'ArnoldiSolver', 'BBBND', 'BBND', 'BFI', 'BND', 'BSpline', 'BaseMatrix', 'BaseVector', 'BilinearForm', 'BitArray', 'BlockBFI', 'BlockLFI', 'BlockMatrix', 'BlockVector', 'BoundaryFromVolumeCF', 'CELL', 'CF', 'CGSolver', 'COUPLING_TYPE', 'CacheCF', 'CoefficientFunction', 'Cof', 'CompoundBFI', 'CompoundLFI', 'Compress', 'CompressCompound', 'Conj', 'ConstEBEMatrix', 'ContactBoundary', 'ConvertOperator', 'CreateVVector', 'Cross', 'Det', 'Deviator', 'DiagonalMatrix', 'Discontinuous', 'Draw', 'EDGE', 'ELEMENT', 'ET', 'ElementId', 'Embedding', 'FACE', 'FACET', 'FESpace', 'FacetFESpace', 'FacetSurface', 'GMRESSolver', 'Grad', 'GridFunction', 'H1', 'H1LumpingFESpace', 'HCurl', 'HCurlAMG', 'HCurlCurl', 'HCurlDiv', 'HDiv', 'HDivDiv', 'HDivDivSurface', 'HDivSurface', 'HEX', 'Hidden', 'Id', 'IdentityMatrix', 'IfPos', 'InnerProduct', 'IntRange', 'Integrate', 'IntegrationRule', 'Interpolate', 'Inv', 'L2', 'LFI', 'LinearForm', 'Matrix', 'MatrixValued', 'Mesh', 'MultiGridPreconditioner', 'MultiVector', 'NodalFESpace', 'NodeId', 'Norm', 'NormalFacetFESpace', 'NormalFacetSurface', 'Normalize', 'NumberSpace', 'ORDER_POLICY', 'OuterProduct', 'PARALLEL_STATUS', 'POINT', 'PRISM', 'PYRAMID', 'PajeTrace', 'ParallelMatrix', 'Parameter', 'ParameterC', 'PatchwiseSolve', 'Periodic', 'PermutationMatrix', 'PlaceholderCF', 'PlateauFESpace', 'Preconditioner', 'PrivateSpace', 'ProductSpace', 'Projector', 'PyCof', 'PyCross', 'PyDet', 'PyId', 'PyInv', 'PySkew', 'PySym', 'PyTrace', 'QMRSolver', 'QUAD', 'Redraw', 'Region', 'SEGM', 'SetHeapSize', 'SetNumThreads', 'SetTestoutFile', 'SetVisualization', 'Skew', 'SurfaceL2', 'Sym', 'SymbolicBFI', 'SymbolicEnergy', 'SymbolicLFI', 'TET', 'TRIG', 'TangentialFacetFESpace', 'TangentialSurfaceL2', 'TaskManager', 'TimeFunction', 'Timer', 'Timers', 'Timing', 'Trace', 'VERTEX', 'VOL', 'VTKOutput', 'Variation', 'Vector', 'VectorFacetFESpace', 'VectorFacetSurface', 'VectorH1', 'VectorL2', 'VectorNodalFESpace', 'VectorSurfaceL2', 'VectorValued', 'VoxelCoefficient', 'ZeroCF', 'acos', 'asin', 'atan', 'atan2', 'atexit', 'bla', 'builtin_sum', 'bvp', 'ceil', 'comp', 'config', 'cos', 'cosh', 'curl', 'directsolvers', 'div', 'ds', 'dx', 'eigenvalues', 'erf', 'exp', 'fem', 'floor', 'grad', 'krylovspace', 'la', 'log', 'netgen', 'ngsglobals', 'ngslib', 'ngstd', 'nonlinearsolvers', 'os', 'pi', 'pml', 'pow', 'preconditioners', 'printonce', 'sin', 'sinh', 'solve', 'solvers', 'specialcf', 'sqrt', 'sum', 'sys', 'tan', 'timestepping', 'timing', 'unit_cube', 'unit_square', 'utils', 'x', 'y', 'z']
194
+ __all__ = ['APhiHCurlAMG', 'ArnoldiSolver', 'BBBND', 'BBND', 'BFI', 'BND', 'BSpline', 'BaseMatrix', 'BaseVector', 'BilinearForm', 'BitArray', 'BlockBFI', 'BlockLFI', 'BlockMatrix', 'BlockVector', 'BoundaryFromVolumeCF', 'CELL', 'CF', 'CGSolver', 'COUPLING_TYPE', 'CacheCF', 'CoefficientFunction', 'Cof', 'CompoundBFI', 'CompoundLFI', 'Compress', 'CompressCompound', 'Conj', 'ConstEBEMatrix', 'ContactBoundary', 'ConvertOperator', 'CreateVVector', 'Cross', 'Det', 'Deviator', 'DiagonalMatrix', 'Discontinuous', 'Draw', 'EDGE', 'ELEMENT', 'ET', 'ElementId', 'Embedding', 'FACE', 'FACET', 'FESpace', 'FacetFESpace', 'FacetSurface', 'GMRESSolver', 'Grad', 'GridFunction', 'H1', 'H1LumpingFESpace', 'HCurl', 'HCurlAMG', 'HCurlCurl', 'HCurlDiv', 'HDiv', 'HDivDiv', 'HDivDivSurface', 'HDivSurface', 'HEX', 'Hidden', 'Id', 'IdentityMatrix', 'IfPos', 'InnerProduct', 'IntRange', 'Integrate', 'IntegrationRule', 'Interpolate', 'Inv', 'L2', 'LFI', 'LinearForm', 'Matrix', 'MatrixValued', 'Mesh', 'MultiGridPreconditioner', 'MultiVector', 'NodalFESpace', 'NodeId', 'Norm', 'NormalFacetFESpace', 'NormalFacetSurface', 'Normalize', 'NumberSpace', 'ORDER_POLICY', 'OuterProduct', 'PARALLEL_STATUS', 'POINT', 'PRISM', 'PYRAMID', 'PajeTrace', 'ParallelMatrix', 'Parameter', 'ParameterC', 'PatchwiseSolve', 'Periodic', 'PermutationMatrix', 'PlaceholderCF', 'PlateauFESpace', 'Preconditioner', 'PrivateSpace', 'ProductSpace', 'Projector', 'PyCof', 'PyCross', 'PyDet', 'PyId', 'PyInv', 'PySkew', 'PySym', 'PyTrace', 'QMRSolver', 'QUAD', 'Redraw', 'Region', 'SEGM', 'SetHeapSize', 'SetNumThreads', 'SetTestoutFile', 'SetVisualization', 'Skew', 'Solve', 'SurfaceL2', 'Sym', 'SymbolicBFI', 'SymbolicEnergy', 'SymbolicLFI', 'TET', 'TRIG', 'TangentialFacetFESpace', 'TangentialSurfaceL2', 'TaskManager', 'TimeFunction', 'Timer', 'Timers', 'Timing', 'Trace', 'VERTEX', 'VOL', 'VTKOutput', 'Variation', 'Vector', 'VectorFacetFESpace', 'VectorFacetSurface', 'VectorH1', 'VectorL2', 'VectorNodalFESpace', 'VectorSurfaceL2', 'VectorValued', 'VoxelCoefficient', 'ZeroCF', 'acos', 'asin', 'atan', 'atan2', 'atexit', 'bla', 'builtin_sum', 'bvp', 'ceil', 'comp', 'config', 'cos', 'cosh', 'curl', 'directsolvers', 'div', 'ds', 'dx', 'eigenvalues', 'erf', 'exp', 'fem', 'floor', 'grad', 'krylovspace', 'la', 'log', 'netgen', 'ngsglobals', 'ngslib', 'ngstd', 'nonlinearsolvers', 'os', 'pi', 'pml', 'pow', 'preconditioners', 'printonce', 'sin', 'sinh', 'solve', 'solve_implementation', 'solvers', 'specialcf', 'sqrt', 'sum', 'sys', 'tan', 'timestepping', 'timing', 'unit_cube', 'unit_square', 'utils', 'x', 'y', 'z']
193
195
  def _add_flags_doc(module):
194
196
  ...
195
197
  def _jupyter_nbextension_paths():
@@ -217,7 +219,7 @@ TET: fem.ET # value = <ET.TET: 20>
217
219
  TRIG: fem.ET # value = <ET.TRIG: 10>
218
220
  VERTEX: fem.NODE_TYPE # value = <NODE_TYPE.VERTEX: 0>
219
221
  VOL: comp.VorB # value = <VorB.VOL: 0>
220
- __version__: str = '6.2.2503'
222
+ __version__: str = '6.2.2504-12-gd2e909551'
221
223
  ds: comp.DifferentialSymbol # value = <ngsolve.comp.DifferentialSymbol object>
222
224
  dx: comp.DifferentialSymbol # value = <ngsolve.comp.DifferentialSymbol object>
223
225
  ngsglobals: comp.GlobalVariables # value = <ngsolve.comp.GlobalVariables object>
ngsolve/bla.pyi CHANGED
@@ -916,8 +916,12 @@ class Vec2D:
916
916
  """
917
917
  Return value at given position
918
918
  """
919
+ @typing.overload
919
920
  def __init__(self, arg0: float, arg1: float) -> None:
920
921
  ...
922
+ @typing.overload
923
+ def __init__(self, t: tuple) -> None:
924
+ ...
921
925
  def __mul__(self, value: float) -> Vec2D:
922
926
  ...
923
927
  def __neg__(self) -> Vec2D:
@@ -971,8 +975,12 @@ class Vec3D:
971
975
  """
972
976
  Return value at given position
973
977
  """
978
+ @typing.overload
974
979
  def __init__(self, arg0: float, arg1: float, arg2: float) -> None:
975
980
  ...
981
+ @typing.overload
982
+ def __init__(self, t: tuple) -> None:
983
+ ...
976
984
  def __mul__(self, value: float) -> Vec3D:
977
985
  ...
978
986
  def __neg__(self) -> Vec3D:
@@ -1,4 +1,4 @@
1
- set(PACKAGE_VERSION "6.2.2503")
1
+ set(PACKAGE_VERSION "6.2.2504-12-gd2e909551")
2
2
  find_package(Netgen CONFIG REQUIRED HINTS
3
3
  ${CMAKE_CURRENT_LIST_DIR}
4
4
  ${CMAKE_CURRENT_LIST_DIR}/..
@@ -23,15 +23,15 @@ set(NGSOLVE_PYBIND_INCLUDE_DIR "")
23
23
  set(NGSOLVE_PYTHON_INCLUDE_DIRS "/Library/Frameworks/Python.framework/Versions/3.12/include/python3.12")
24
24
  set(NGSOLVE_PYTHON_LIBRARIES "/Library/Frameworks/Python.framework/Versions/3.12/lib/libpython3.12.dylib")
25
25
  set(NGSOLVE_PYTHON_PACKAGES_INSTALL_DIR "")
26
- set(NGSOLVE_TCL_INCLUDE_PATH "/Users/gitlab-runner/builds/builds/rL7WHzyj/0/ngsolve/netgen/_skbuild/macosx-10.15-universal2-3.12/cmake-build/dependencies/src/project_tcl/generic")
26
+ set(NGSOLVE_TCL_INCLUDE_PATH "/Users/gitlab-runner/builds/builds/rL7WHzyj/0/ngsolve/ngsolve/external_dependencies/netgen/_skbuild/macosx-10.15-universal2-3.12/cmake-build/dependencies/src/project_tcl/generic")
27
27
  set(NGSOLVE_TCL_LIBRARY "/Library/Frameworks/Python.framework/Versions/3.12/lib/libtclstub8.6.a")
28
28
  set(NGSOLVE_TK_DND_LIBRARY "")
29
- set(NGSOLVE_TK_INCLUDE_PATH "/Users/gitlab-runner/builds/builds/rL7WHzyj/0/ngsolve/netgen/_skbuild/macosx-10.15-universal2-3.12/cmake-build/dependencies/src/project_tk/generic")
29
+ set(NGSOLVE_TK_INCLUDE_PATH "/Users/gitlab-runner/builds/builds/rL7WHzyj/0/ngsolve/ngsolve/external_dependencies/netgen/_skbuild/macosx-10.15-universal2-3.12/cmake-build/dependencies/src/project_tk/generic")
30
30
  set(NGSOLVE_TK_LIBRARY "/Library/Frameworks/Python.framework/Versions/3.12/lib/libtkstub8.6.a")
31
31
  set(NGSOLVE_X11_X11_LIB "")
32
32
  set(NGSOLVE_X11_Xmu_LIB "")
33
- set(NGSOLVE_ZLIB_INCLUDE_DIRS "/Users/gitlab-runner/builds/builds/rL7WHzyj/0/ngsolve/netgen/_skbuild/macosx-10.15-universal2-3.12/cmake-build/dependencies/zlib/include")
34
- set(NGSOLVE_ZLIB_LIBRARIES "/Users/gitlab-runner/builds/builds/rL7WHzyj/0/ngsolve/netgen/_skbuild/macosx-10.15-universal2-3.12/cmake-build/dependencies/zlib/lib/libz.a")
33
+ set(NGSOLVE_ZLIB_INCLUDE_DIRS "/Users/gitlab-runner/builds/builds/rL7WHzyj/0/ngsolve/ngsolve/external_dependencies/netgen/_skbuild/macosx-10.15-universal2-3.12/cmake-build/dependencies/zlib/include")
34
+ set(NGSOLVE_ZLIB_LIBRARIES "/Users/gitlab-runner/builds/builds/rL7WHzyj/0/ngsolve/ngsolve/external_dependencies/netgen/_skbuild/macosx-10.15-universal2-3.12/cmake-build/dependencies/zlib/lib/libz.a")
35
35
 
36
36
  set(NGSOLVE_INTEL_MIC OFF)
37
37
  set(NGSOLVE_USE_CCACHE ON)
ngsolve/comp/__init__.pyi CHANGED
@@ -7,24 +7,22 @@ import ngsolve.bla
7
7
  import ngsolve.fem
8
8
  import ngsolve.la
9
9
  import ngsolve.ngstd
10
+ import ngsolve.solve_implementation
10
11
  import numpy
11
12
  import pyngcore.pyngcore
12
13
  import typing
13
14
  from . import pml
14
- __all__ = ['APhiHCurlAMG', 'Array_N6ngcomp13COUPLING_TYPEE_S', 'BBBND', 'BBND', 'BDDCPreconditioner', 'BDDCPreconditioner_complex', 'BDDCPreconditioner_double', 'BND', 'BilinearForm', 'BndElementId', 'BoundaryFromVolumeCF', 'COUPLING_TYPE', 'ComponentGridFunction', 'Compress', 'CompressCompound', 'ContactBoundary', 'ConvertOperator', 'DifferentialSymbol', 'Discontinuous', 'DualProxyFunction', 'ElementId', 'ElementRange', 'FESpace', 'FESpaceElement', 'FESpaceElementRange', 'FacetFESpace', 'FacetSurface', 'FlatArray_N6ngcomp13COUPLING_TYPEE_S', 'FromArchiveCF', 'FromArchiveFESpace', 'FromArchiveMesh', 'GlobalInterfaceSpace', 'GlobalSpace', 'GlobalVariables', 'GridFunction', 'GridFunctionC', 'GridFunctionCoefficientFunction', 'GridFunctionD', 'H1', 'H1LumpingFESpace', 'HCurl', 'HCurlAMG', 'HCurlCurl', 'HCurlDiv', 'HDiv', 'HDivDiv', 'HDivDivSurface', 'HDivSurface', 'Hidden', 'Integral', 'Integrate', 'IntegrationRuleSpace', 'IntegrationRuleSpaceSurface', 'Interpolate', 'InterpolateProxy', 'KSpaceCoeffs', 'L2', 'LinearForm', 'LocalPreconditioner', 'MatrixFreeOperator', 'MatrixValued', 'Mesh', 'MeshNode', 'MeshNodeRange', 'MultiGridPreconditioner', 'NGS_Object', 'Ngs_Element', 'NodalFESpace', 'NodeId', 'NodeRange', 'NormalFacetFESpace', 'NormalFacetSurface', 'NumberSpace', 'ORDER_POLICY', 'PatchwiseSolve', 'Periodic', 'PlateauFESpace', 'Preconditioner', 'ProductSpace', 'Prolongate', 'ProlongateCoefficientFunction', 'Prolongation', 'ProxyFunction', 'QuasiPeriodicC', 'QuasiPeriodicD', 'Region', 'RegisterPreconditioner', 'Reorder', 'SetHeapSize', 'SetTestoutFile', 'SumOfIntegrals', 'SurfaceL2', 'SymbolTable_D', 'SymbolTable_sp_D', 'SymbolTable_sp_N5ngfem19CoefficientFunctionE', 'SymbolTable_sp_N6ngcomp10LinearFormE', 'SymbolTable_sp_N6ngcomp12BilinearFormE', 'SymbolTable_sp_N6ngcomp12GridFunctionE', 'SymbolTable_sp_N6ngcomp14PreconditionerE', 'SymbolTable_sp_N6ngcomp7FESpaceE', 'SymbolicBFI', 'SymbolicEnergy', 'SymbolicLFI', 'SymbolicTPBFI', 'TangentialFacetFESpace', 'TangentialSurfaceL2', 'TensorProductFESpace', 'TensorProductIntegrate', 'ToArchive', 'Transfer2StdMesh', 'VOL', 'VTKOutput', 'Variation', 'VectorFacetFESpace', 'VectorFacetSurface', 'VectorH1', 'VectorL2', 'VectorNodalFESpace', 'VectorSurfaceL2', 'VectorValued', 'VorB', 'ngsglobals', 'pml']
15
+ __all__ = ['APhiHCurlAMG', 'Array_N6ngcomp13COUPLING_TYPEE_S', 'BBBND', 'BBND', 'BDDCPreconditioner', 'BDDCPreconditioner_complex', 'BDDCPreconditioner_double', 'BND', 'BilinearForm', 'BndElementId', 'BoundaryFromVolumeCF', 'COUPLING_TYPE', 'ComponentGridFunction', 'Compress', 'CompressCompound', 'ContactBoundary', 'ConvertOperator', 'DifferentialSymbol', 'Discontinuous', 'DualProxyFunction', 'ElementId', 'ElementRange', 'FESpace', 'FESpaceElement', 'FESpaceElementRange', 'FacetFESpace', 'FacetSurface', 'FlatArray_N6ngcomp13COUPLING_TYPEE_S', 'FromArchiveCF', 'FromArchiveFESpace', 'FromArchiveMesh', 'GlobalInterfaceSpace', 'GlobalSpace', 'GlobalVariables', 'GridFunction', 'GridFunctionC', 'GridFunctionCoefficientFunction', 'GridFunctionD', 'H1', 'H1AMG', 'H1LumpingFESpace', 'HCurl', 'HCurlAMG', 'HCurlCurl', 'HCurlDiv', 'HDiv', 'HDivDiv', 'HDivDivSurface', 'HDivSurface', 'Hidden', 'Integral', 'Integrate', 'IntegrationRuleSpace', 'IntegrationRuleSpaceSurface', 'Interpolate', 'InterpolateProxy', 'KSpaceCoeffs', 'L2', 'LinearForm', 'LocalPreconditioner', 'MatrixFreeOperator', 'MatrixValued', 'Mesh', 'MeshNode', 'MeshNodeRange', 'MultiGridPreconditioner', 'NGS_Object', 'Ngs_Element', 'NodalFESpace', 'NodeId', 'NodeRange', 'NormalFacetFESpace', 'NormalFacetSurface', 'NumberSpace', 'ORDER_POLICY', 'PatchwiseSolve', 'Periodic', 'PlateauFESpace', 'Preconditioner', 'ProductSpace', 'Prolongate', 'ProlongateCoefficientFunction', 'Prolongation', 'ProxyFunction', 'QuasiPeriodicC', 'QuasiPeriodicD', 'Region', 'RegisterPreconditioner', 'Reorder', 'SetHeapSize', 'SetTestoutFile', 'SumOfIntegrals', 'SurfaceL2', 'SymbolTable_D', 'SymbolTable_sp_D', 'SymbolTable_sp_N5ngfem19CoefficientFunctionE', 'SymbolTable_sp_N6ngcomp10LinearFormE', 'SymbolTable_sp_N6ngcomp12BilinearFormE', 'SymbolTable_sp_N6ngcomp12GridFunctionE', 'SymbolTable_sp_N6ngcomp14PreconditionerE', 'SymbolTable_sp_N6ngcomp7FESpaceE', 'SymbolicBFI', 'SymbolicEnergy', 'SymbolicLFI', 'SymbolicTPBFI', 'TangentialFacetFESpace', 'TangentialSurfaceL2', 'TensorProductFESpace', 'TensorProductIntegrate', 'ToArchive', 'Transfer2StdMesh', 'VOL', 'VTKOutput', 'Variation', 'VectorFacetFESpace', 'VectorFacetSurface', 'VectorH1', 'VectorL2', 'VectorNodalFESpace', 'VectorSurfaceL2', 'VectorValued', 'VorB', 'ngsglobals', 'pml']
15
16
  class APhiHCurlAMG(HCurlAMG):
16
17
  """
17
18
 
18
19
  Keyword arguments can be:
19
- inverse:
20
- Inverse type used in Preconditioner.
21
- test: bool = False
22
- Computes condition number for preconditioner, if testout file
23
- is set, prints eigenvalues to file.
24
- block:
25
- use block-Jacobi/block-Gauss-Seidel
26
- blocktype:
27
- blocktype like 'vertexpatch', 'edgepatch', ...
20
+ smoothingsteps: int = 3
21
+ number of pre and post-smoothing steps
22
+ smoothedprolongation: bool = true
23
+ use smoothed prolongation
24
+ verbose: int = 3
25
+ verbosity level, 0..no output, 5..most output
28
26
  """
29
27
  def __init__(self, bf: BilinearForm, **kwargs) -> None:
30
28
  ...
@@ -230,6 +228,10 @@ class BilinearForm(NGS_Object):
230
228
  ...
231
229
  def UnsetPreconditioner(self, arg0: ...) -> None:
232
230
  ...
231
+ @typing.overload
232
+ def __call__(self, gfu: GridFunction) -> typing.Any:
233
+ ...
234
+ @typing.overload
233
235
  def __call__(self, gfu: GridFunction, gfv: GridFunction) -> float:
234
236
  ...
235
237
  @typing.overload
@@ -250,6 +252,8 @@ class BilinearForm(NGS_Object):
250
252
  @typing.overload
251
253
  def __init__(self, arg0: SumOfIntegrals, **kwargs) -> None:
252
254
  ...
255
+ def __mul__(self, gfu: GridFunction) -> ngsolve.solve_implementation.LinearApplication:
256
+ ...
253
257
  def __str__(self) -> str:
254
258
  ...
255
259
  @property
@@ -1710,6 +1714,18 @@ class H1(FESpace):
1710
1714
  ...
1711
1715
  def __setstate__(self, arg0: tuple) -> None:
1712
1716
  ...
1717
+ class H1AMG(Preconditioner):
1718
+ """
1719
+
1720
+ Keyword arguments can be:
1721
+ blockjustfortest: bool = false
1722
+ use block Jacobi/Gauss-Seidel
1723
+ """
1724
+ @staticmethod
1725
+ def __flags_doc__() -> dict:
1726
+ ...
1727
+ def __init__(self, bf: BilinearForm, **kwargs) -> None:
1728
+ ...
1713
1729
  class H1LumpingFESpace(FESpace):
1714
1730
  """
1715
1731
  H1-FESpace with nodal basis for mass lumping.
@@ -1855,16 +1871,16 @@ class HCurlAMG(Preconditioner):
1855
1871
  """
1856
1872
 
1857
1873
  Keyword arguments can be:
1858
- inverse:
1859
- Inverse type used in Preconditioner.
1860
- test: bool = False
1861
- Computes condition number for preconditioner, if testout file
1862
- is set, prints eigenvalues to file.
1863
- block:
1864
- use block-Jacobi/block-Gauss-Seidel
1865
- blocktype:
1866
- blocktype like 'vertexpatch', 'edgepatch', ...
1874
+ smoothingsteps: int = 3
1875
+ number of pre and post-smoothing steps
1876
+ smoothedprolongation: bool = true
1877
+ use smoothed prolongation
1878
+ verbose: int = 3
1879
+ verbosity level, 0..no output, 5..most output
1867
1880
  """
1881
+ @staticmethod
1882
+ def __flags_doc__() -> dict:
1883
+ ...
1868
1884
  def __init__(self, bf: BilinearForm, **kwargs) -> None:
1869
1885
  ...
1870
1886
  class HCurlCurl(FESpace):
@@ -24,14 +24,14 @@ NGSOLVE_INSTALL_DIR_INCLUDE: str = 'netgen/include'
24
24
  NGSOLVE_INSTALL_DIR_LIB: str = 'netgen'
25
25
  NGSOLVE_INSTALL_DIR_PYTHON: str = '.'
26
26
  NGSOLVE_INSTALL_DIR_RES: str = 'share'
27
- NGSOLVE_VERSION: str = '6.2.2503'
28
- NGSOLVE_VERSION_GIT: str = 'v6.2.2503-0-ga44fe5348'
29
- NGSOLVE_VERSION_HASH: str = 'ga44fe5348'
27
+ NGSOLVE_VERSION: str = '6.2.2504-12-gd2e909551'
28
+ NGSOLVE_VERSION_GIT: str = 'v6.2.2504-12-gd2e909551'
29
+ NGSOLVE_VERSION_HASH: str = 'gd2e909551'
30
30
  NGSOLVE_VERSION_MAJOR: str = '6'
31
31
  NGSOLVE_VERSION_MINOR: str = '2'
32
- NGSOLVE_VERSION_PATCH: str = '2503'
33
- NGSOLVE_VERSION_PYTHON: str = '6.2.2503'
34
- NGSOLVE_VERSION_TWEAK: str = '0'
32
+ NGSOLVE_VERSION_PATCH: str = '2504'
33
+ NGSOLVE_VERSION_PYTHON: str = '6.2.2504.post12.dev0'
34
+ NGSOLVE_VERSION_TWEAK: str = '12'
35
35
  USE_CCACHE: bool = True
36
36
  USE_HYPRE: bool = False
37
37
  USE_LAPACK: bool = True
@@ -40,4 +40,4 @@ USE_MUMPS: bool = False
40
40
  USE_PARDISO: bool = False
41
41
  USE_UMFPACK: bool = True
42
42
  is_python_package: bool = True
43
- version: str = 'v6.2.2503-0-ga44fe5348'
43
+ version: str = 'v6.2.2504-12-gd2e909551'
ngsolve/config/config.py CHANGED
@@ -29,15 +29,15 @@ NGSOLVE_INSTALL_DIR_INCLUDE = "netgen/include"
29
29
  NGSOLVE_INSTALL_DIR_CMAKE = "ngsolve/cmake"
30
30
  NGSOLVE_INSTALL_DIR_RES = "share"
31
31
 
32
- NGSOLVE_VERSION = "6.2.2503"
33
- NGSOLVE_VERSION_GIT = "v6.2.2503-0-ga44fe5348"
34
- NGSOLVE_VERSION_PYTHON = "6.2.2503"
32
+ NGSOLVE_VERSION = "6.2.2504-12-gd2e909551"
33
+ NGSOLVE_VERSION_GIT = "v6.2.2504-12-gd2e909551"
34
+ NGSOLVE_VERSION_PYTHON = "6.2.2504.post12.dev0"
35
35
 
36
36
  NGSOLVE_VERSION_MAJOR = "6"
37
37
  NGSOLVE_VERSION_MINOR = "2"
38
- NGSOLVE_VERSION_TWEAK = "0"
39
- NGSOLVE_VERSION_PATCH = "2503"
40
- NGSOLVE_VERSION_HASH = "ga44fe5348"
38
+ NGSOLVE_VERSION_TWEAK = "12"
39
+ NGSOLVE_VERSION_PATCH = "2504"
40
+ NGSOLVE_VERSION_HASH = "gd2e909551"
41
41
 
42
42
  CMAKE_CXX_COMPILER = "/Library/Developer/CommandLineTools/usr/bin/c++"
43
43
  CMAKE_CUDA_COMPILER = ""
ngsolve/config/config.pyi CHANGED
@@ -26,14 +26,14 @@ NGSOLVE_INSTALL_DIR_INCLUDE: str = 'netgen/include'
26
26
  NGSOLVE_INSTALL_DIR_LIB: str = 'netgen'
27
27
  NGSOLVE_INSTALL_DIR_PYTHON: str = '.'
28
28
  NGSOLVE_INSTALL_DIR_RES: str = 'share'
29
- NGSOLVE_VERSION: str = '6.2.2503'
30
- NGSOLVE_VERSION_GIT: str = 'v6.2.2503-0-ga44fe5348'
31
- NGSOLVE_VERSION_HASH: str = 'ga44fe5348'
29
+ NGSOLVE_VERSION: str = '6.2.2504-12-gd2e909551'
30
+ NGSOLVE_VERSION_GIT: str = 'v6.2.2504-12-gd2e909551'
31
+ NGSOLVE_VERSION_HASH: str = 'gd2e909551'
32
32
  NGSOLVE_VERSION_MAJOR: str = '6'
33
33
  NGSOLVE_VERSION_MINOR: str = '2'
34
- NGSOLVE_VERSION_PATCH: str = '2503'
35
- NGSOLVE_VERSION_PYTHON: str = '6.2.2503'
36
- NGSOLVE_VERSION_TWEAK: str = '0'
34
+ NGSOLVE_VERSION_PATCH: str = '2504'
35
+ NGSOLVE_VERSION_PYTHON: str = '6.2.2504.post12.dev0'
36
+ NGSOLVE_VERSION_TWEAK: str = '12'
37
37
  USE_CCACHE: bool = True
38
38
  USE_HYPRE: bool = False
39
39
  USE_LAPACK: bool = True
@@ -42,4 +42,4 @@ USE_MUMPS: bool = False
42
42
  USE_PARDISO: bool = False
43
43
  USE_UMFPACK: bool = True
44
44
  is_python_package: bool = True
45
- version: str = 'v6.2.2503-0-ga44fe5348'
45
+ version: str = 'v6.2.2504-12-gd2e909551'
ngsolve/fem.pyi CHANGED
@@ -403,6 +403,12 @@ class CoefficientFunction:
403
403
  def __neg__(self) -> CoefficientFunction:
404
404
  ...
405
405
  @typing.overload
406
+ def __or__(self, cf: CoefficientFunction) -> CoefficientFunction:
407
+ ...
408
+ @typing.overload
409
+ def __or__(self, cf: ...) -> typing.Any:
410
+ ...
411
+ @typing.overload
406
412
  def __pow__(self, exponent: int) -> CoefficientFunction:
407
413
  ...
408
414
  @typing.overload
@@ -1,6 +1,7 @@
1
1
  from ngsolve.comp import MultiGridPreconditioner as MultiGrid
2
2
  from ngsolve.comp import LocalPreconditioner as Local
3
3
  from ngsolve.comp import HCurlAMG
4
+ from ngsolve.comp import H1AMG
4
5
  from ngsolve.comp import BDDCPreconditioner as BDDC
5
6
 
6
7
 
@@ -1,6 +1,7 @@
1
1
  from __future__ import annotations
2
2
  from ngsolve.comp import BDDCPreconditioner as BDDC
3
+ from ngsolve.comp import H1AMG
3
4
  from ngsolve.comp import HCurlAMG
4
5
  from ngsolve.comp import LocalPreconditioner as Local
5
6
  from ngsolve.comp import MultiGridPreconditioner as MultiGrid
6
- __all__ = ['BDDC', 'HCurlAMG', 'Local', 'MultiGrid']
7
+ __all__ = ['BDDC', 'H1AMG', 'HCurlAMG', 'Local', 'MultiGrid']