diff --git a/hysop/__init__.py.in b/hysop/__init__.py.in
index e36b750741cc56036e1bce8c031c69775fc4413b..8ccdf4416a6cbdd3bc4653e86f2e5f9ef0c093b3 100644
--- a/hysop/__init__.py.in
+++ b/hysop/__init__.py.in
@@ -138,7 +138,3 @@ msg_io =  '\n*Default path for all i/o is \'{}\'.'.format(default_path)
 msg_io += '\n*Default path for caching is \'{}\'.'.format(cache_path)
 mprint(msg_io)
 mprint()
-
-if ('CLFFT_CACHE_PATH' not in os.environ):
-    os.environ['CLFFT_CACHE_PATH'] = cache_path + '/clfft'
-
diff --git a/hysop/backend/device/opencl/__init__.py b/hysop/backend/device/opencl/__init__.py
index bee50ebafe21f54ae7809e301ecf3492f0bdc144..46bb5f844af2f54aeebdd5c6a32b672a7044d321 100644
--- a/hysop/backend/device/opencl/__init__.py
+++ b/hysop/backend/device/opencl/__init__.py
@@ -6,6 +6,7 @@ see hysop.backend.device.opencl.opencl_tools.parse_file
 see hysop.backend.device.codegen
 """
 
+import os
 import pyopencl
 import pyopencl.tools
 import pyopencl.array
@@ -16,6 +17,7 @@ import pyopencl.elementwise
 import pyopencl.scan
 
 from hysop import __DEFAULT_PLATFORM_ID__, __DEFAULT_DEVICE_ID__
+from hysop.tools.io_utils import IO
 from hysop.backend.device import KERNEL_DUMP_FOLDER
 
 OPENCL_KERNEL_DUMP_FOLDER='{}/opencl'.format(KERNEL_DUMP_FOLDER)
@@ -51,3 +53,12 @@ clCharacterize = pyopencl.characterize
 
 from pyopencl._cffi import ffi as cl_ffi, lib as cl_lib
 from pyopencl import cffi_cl
+
+if ('CLFFT_CACHE_PATH' not in os.environ):
+    os.environ['CLFFT_CACHE_PATH'] = IO.default_cache_path() + '/clfft'
+if not os.path.isdir(os.environ['CLFFT_CACHE_PATH']):
+    try:
+        os.makedirs(os.environ['CLFFT_CACHE_PATH'])
+    except:
+        print("Could not create clfft cache directory '{}'.".format(
+            os.environ['CLFFT_CACHE_PATH']))
diff --git a/hysop/backend/device/opencl/operator/derivative.py b/hysop/backend/device/opencl/operator/derivative.py
index 0b10513ecbb37ffae28102f0b2dc1bcab2c23723..af47344331282a0173fb8cd5c2744285a96d653c 100644
--- a/hysop/backend/device/opencl/operator/derivative.py
+++ b/hysop/backend/device/opencl/operator/derivative.py
@@ -131,16 +131,11 @@ class OpenClSpectralSpaceDerivative(SpectralSpaceDerivativeBase, OpenClSymbolic)
 
     
     @op_apply
-    def apply(self, dd, **kwds):
+    def apply(self, **kwds):
         queue = self.cl_env.default_queue
-        dd(0, 0.0, 'Fin', self.Ft.input_buffer.get())
         self.Ft().wait()
-        dd(1, 0.0, 'Fout', self.Ft.output_buffer.get())
         self.compute_derivative_kernel(queue=queue).wait()
-        dd(2, 0.0, 'Bin', self.Bt.input_buffer.get())
         self.Bt().wait()
-        dd(3, 0.0, 'Bout', self.Bt.input_buffer.get())
         self.scale_derivative_kernel(queue=queue, **self.scale_update_parameters())
         self.dFout.exchange_ghosts()
-        dd(4, 0.0, 'dFout', self.dFout.sdata.get().handle)
 
diff --git a/hysop/backend/device/opencl/operator/poisson.py b/hysop/backend/device/opencl/operator/poisson.py
index b5e069182908c273f75206ce9902b6dbc2b4ee42..8a583eaece4f64f4f8322de8c15fd49444b73dcf 100644
--- a/hysop/backend/device/opencl/operator/poisson.py
+++ b/hysop/backend/device/opencl/operator/poisson.py
@@ -38,7 +38,6 @@ class OpenClPoisson(PoissonOperatorBase, OpenClSymbolic):
                 F += indexed_Wi
             cond = LogicalAND(*tuple(LogicalEQ(idx,0) for idx in indices))
             expr = Assignment(Fhs, Select(Fhs/F, 0, cond))
-            print expr
             
             self.require_symbolic_kernel(kname, expr)
 
diff --git a/hysop/backend/host/fortran/operator/fortran_fftw.py b/hysop/backend/host/fortran/operator/fortran_fftw.py
index 27e0f496d3fc989f126735ddea8c804df1e0cd0f..529453a8875dd22a569249f46141808fb4883b8b 100644
--- a/hysop/backend/host/fortran/operator/fortran_fftw.py
+++ b/hysop/backend/host/fortran/operator/fortran_fftw.py
@@ -8,7 +8,7 @@ except ImportError:
     msg += 'Try to recompile HySoP with WITH_FFTW=ON'
     raise ImportError(msg)
 
-from hysop.constants import HYSOP_ORDER, HYSOP_REAL, TranspositionState
+from hysop.constants import HYSOP_ORDER, HYSOP_REAL, TranspositionState, BoundaryCondition
 from hysop.tools.numpywrappers import npw
 from hysop.tools.decorators import debug
 from hysop.tools.types import check_instance
@@ -35,6 +35,16 @@ class FortranFFTWOperator(FortranOperator):
                     msg+='\nHYSOP_REAL is {} but field {} has dtype {}.'
                     msg=msg.format(HYSOP_REAL.__name__, fi.name, fi.dtype)
                     raise RuntimeError(msg)
+                if (any((bd!=BoundaryCondition.PERIODIC) for bd in fi.lboundaries) or
+                    any((bd!=BoundaryCondition.PERIODIC) for bd in fi.rboundaries)):
+                    msg='FortranFFTW operators only work with PERIODIC boundary conditions:'
+                    msg+='\n  operator:    {}'.format(self.name)
+                    msg+='\n  field:       {}'.format(fi.pretty_name)
+                    msg+='\n  lboundaries: {}'.format(fi.lboundaries)
+                    msg+='\n  rboundaries: {}'.format(fi.rboundaries)
+                    raise RuntimeError(msg)
+
+
 
         domain = self.input_fields.keys()[0].domain
         self.dim      = domain.dim
diff --git a/hysop/backend/host/python/operator/derivative.py b/hysop/backend/host/python/operator/derivative.py
index 1b09ae780428dec3135fe5452d25cd759d2c583c..e6a4cb18cbfbec39ed6c2460ff8900302c1019a8 100644
--- a/hysop/backend/host/python/operator/derivative.py
+++ b/hysop/backend/host/python/operator/derivative.py
@@ -25,17 +25,12 @@ class PythonSpectralSpaceDerivative(SpectralSpaceDerivativeBase, HostOperator):
             self.scale = dA
     
     @op_apply
-    def apply(self, dd, **kwds):
-        dd(0, 0.0, 'Fin', self.Ft.input_buffer)
+    def apply(self, **kwds):
         self.Ft()
-        dd(1, 0.0, 'Fout', self.Ft.output_buffer)
         self.compute_derivative()
-        dd(2, 0.0, 'Bin', self.Bt.input_buffer)
         self.Bt()
-        dd(3, 0.0, 'Bout', self.Bt.input_buffer)
         self.scale_derivative()
         self.dFout.exchange_ghosts()
-        dd(4, 0.0, 'dFout', self.dFout)
 
     def compute_derivative(self):
         from hysop.constants import BoxBoundaryCondition
diff --git a/hysop/backend/host/python/operator/poisson.py b/hysop/backend/host/python/operator/poisson.py
index 050e14589b5b9e4f01c66d0188eee1df74616fbe..29d28b0bff43ae37b58e9e45fe6ce56977a81833 100644
--- a/hysop/backend/host/python/operator/poisson.py
+++ b/hysop/backend/host/python/operator/poisson.py
@@ -90,13 +90,13 @@ def filter_poisson_4d(Fin, K0, K1, K2, K3, Fout):
 
 class PythonPoisson(PoissonOperatorBase, HostOperator):
     """
-    Solves the poisson equation using a python host fft backend (numpy or scipy).
+    Solves the poisson equation using one of the host python fft backend (fftw, numpy or scipy).
     """
            
     def setup(self, work):
         super(PythonPoisson, self).setup(work=work)
         poisson_filters = ()
-        for (Fo,Ft,Kd) in zip(self.dFout, self.forward_transforms, self.all_dkds): 
+        for (Fo,Ft,Kd) in zip(self.dFout.dfields, self.forward_transforms, self.all_dkds): 
             if (Fo.dim==1):
                 F = functools.partial(filter_poisson_1d, Ft.output_buffer, Kd[0], Ft.output_buffer)
             elif (Fo.dim==2):
@@ -117,7 +117,7 @@ class PythonPoisson(PoissonOperatorBase, HostOperator):
         """Solve the Poisson equation."""
         super(PythonPoisson, self).apply(**kwds)
         
-        for (Fo,Ft,Bt,filter_poisson) in zip(self.dFout, 
+        for (Fo,Ft,Bt,filter_poisson) in zip(self.dFout.dfields, 
                                              self.forward_transforms,
                                              self.backward_transforms,
                                              self.poisson_filters):
diff --git a/hysop/operator/base/poisson.py b/hysop/operator/base/poisson.py
index 3b26c99a6997270fa0b1ab92f71d6e233dca1bb4..665688b5ba03393e11a4110af983a1825054be1c 100644
--- a/hysop/operator/base/poisson.py
+++ b/hysop/operator/base/poisson.py
@@ -56,7 +56,7 @@ class PoissonOperatorBase(SpectralOperatorBase):
         wave_numbers        = ()
         
         tg = self.new_transform_group()
-        for (Fi,Fo) in zip(Fin, Fout):
+        for (Fi,Fo) in zip(Fin.fields, Fout.fields):
             Ft = tg.require_forward_transform(Fi, custom_output_buffer='auto')
             Bt = tg.require_backward_transform(Fo, custom_input_buffer='auto',
                                                 matching_forward_transform=Ft)
diff --git a/hysop/operator/base/spectral_operator.py b/hysop/operator/base/spectral_operator.py
index 25a0f3ff134982299397c7132e46ed4cc8c751aa..9d04f396865c83564e42cb5b35b38e4307007a22 100644
--- a/hysop/operator/base/spectral_operator.py
+++ b/hysop/operator/base/spectral_operator.py
@@ -311,12 +311,9 @@ class SpectralTransformGroup(object):
         compute_data = (compute_dtype, compute_axes, compute_shape)
 
         discrete_wave_numbers = {}
-        print
-        print 'compute_axes: {}'.format(compute_axes)
         for wn in self._wave_numbers:
             (idx, freqs, nd_freqs) = self.build_wave_number(domain, grid_resolution,
                                                           backend, wn, *compute_data)
-            print 'Wn={}, axis={}, idx={}, tst={}'.format(wn, wn.axis, idx, compute_axes.index(wn.axis))
             self._indexed_wave_numbers[wn].indexed_object.to_backend(backend.kind).bind_memory_object(freqs)
             self._indexed_wave_numbers[wn].index.bind_axes(compute_axes)
             discrete_wave_numbers[wn] = (idx, freqs, nd_freqs)
diff --git a/hysop/operator/tests/test_poisson.py b/hysop/operator/tests/test_poisson.py
index 0bf90be47dcb82a3d53bd5c006c9af45016de719..e15b6c8eb468878230a40c4d2ae9cbb969fedc48 100644
--- a/hysop/operator/tests/test_poisson.py
+++ b/hysop/operator/tests/test_poisson.py
@@ -156,12 +156,12 @@ class TestPoissonOperator(object):
 
         msg='\nTesting {}D Poisson: dtype={} nb_components={} shape={} polynomial={}, bc=[{}]'.format(
                 dim, dtype.__name__, nb_components, shape, polynomial, W.domain.format_boundaries())
-        msg+='\n >Corresponding field boundary conditions are [{}].'.format(W[0].format_boundaries())
+        msg+='\n >Corresponding field boundary conditions are [{}].'.format(W.fields[0].format_boundaries())
         msg+='\n >Input analytic functions are (truncated):'
-        for (Wi, Wis) in zip(W, analytic_expressions['W']):
+        for (Wi, Wis) in zip(W.fields, analytic_expressions['W']):
             msg+='\n   *{}(x,t) = {}'.format(Wi.pretty_name, format_expr(Wis))
         msg+='\n >Expected output solutions:'
-        for (Psi_i, Psis_i) in zip(Psi, analytic_expressions['Psi']):
+        for (Psi_i, Psis_i) in zip(Psi.fields, analytic_expressions['Psi']):
             msg+='\n   *{}(x,t) = {}'.format(Psi_i.pretty_name, format_expr(Psis_i))
         msg+='\n >Testing all implementations:'
         print msg
@@ -197,7 +197,9 @@ class TestPoissonOperator(object):
         Wref = None
         for impl in implementations:
             if (impl is Implementation.FORTRAN):
-                if ((nb_components>1) or (dim!=3) or (not dtype is HYSOP_REAL)):
+                if ((nb_components>1) or (dim!=3) or (not dtype is HYSOP_REAL)
+                        or any((bd != BoundaryCondition.PERIODIC) for bd in W.lboundaries)
+                        or any((bd != BoundaryCondition.PERIODIC) for bd in W.rboundaries)):
                     print '   *Fortran FFTW: NO SUPPORT'
                     continue
             elif (impl is Implementation.OPENCL):
@@ -343,19 +345,19 @@ class TestPoissonOperator(object):
         max_3d_runs = None if __ENABLE_LONG_TESTS__ else 5
         max_4d_runs = None if __ENABLE_LONG_TESTS__ else 5
 
-        #self.test_1d_float32(max_runs=max_1d_runs)
-        #self.test_2d_float32(max_runs=max_2d_runs)
+        self.test_1d_float32(max_runs=max_1d_runs)
+        self.test_2d_float32(max_runs=max_2d_runs)
         self.test_3d_float32(max_runs=max_3d_runs)
-        #self.test_4d_float32(max_runs=max_4d_runs)
+        self.test_4d_float32(max_runs=max_4d_runs)
 
-        #self.test_1d_float64(max_runs=max_1d_runs)
-        #self.test_2d_float64(max_runs=max_2d_runs)
-        #self.test_3d_float64(max_runs=max_3d_runs)
-        #self.test_4d_float32(max_runs=max_4d_runs)
+        self.test_1d_float64(max_runs=max_1d_runs)
+        self.test_2d_float64(max_runs=max_2d_runs)
+        self.test_3d_float64(max_runs=max_3d_runs)
+        self.test_4d_float32(max_runs=max_4d_runs)
 
 if __name__ == '__main__':
     TestPoissonOperator.setup_class(enable_extra_tests=False,
-                                    enable_debug_mode=True)
+                                    enable_debug_mode=False)
 
     test = TestPoissonOperator()
 
diff --git a/hysop/operator/tests/test_spectral_derivative.py b/hysop/operator/tests/test_spectral_derivative.py
index 750b0d4ce7207640c230d7f0c47878eef7d81500..153116f7536f555c205acd783f6fca5483468bf5 100644
--- a/hysop/operator/tests/test_spectral_derivative.py
+++ b/hysop/operator/tests/test_spectral_derivative.py
@@ -20,9 +20,6 @@ from hysop.operator.misc import ForceTopologyState
 
 from hysop import Field, Box
 
-npw.random.seed(seed=0)
-from hysop.tools.debug_dumper import DebugDumper
-
 class TestSpectralDerivative(object):
 
     @classmethod
@@ -33,7 +30,7 @@ class TestSpectralDerivative(object):
         IO.set_default_path('/tmp/hysop_tests/test_spectral_derivative')
         
         cls.size_min = 8
-        cls.size_max = 8
+        cls.size_max = 16
         
         cls.enable_extra_tests = enable_extra_tests
         cls.enable_debug_mode  = enable_debug_mode
@@ -136,7 +133,6 @@ class TestSpectralDerivative(object):
             domain, F, polynomial, max_derivative):
         
         implementations = SpectralSpaceDerivative.implementations()
-        implementations = [Implementation.OPENCL]
 
         (symbolic_dvars, analytic_expressions, analytic_functions) = \
             self.build_analytic_expressions(
@@ -162,8 +158,6 @@ class TestSpectralDerivative(object):
         print msg
 
         for idx in sorted(symbolic_dvars.keys(), key=lambda x: sum(x)):
-            if sum(idx)!=2:
-                continue
             xvars = symbolic_dvars[idx]
             dFe = F.s()
             for (ci,i) in xvars:
@@ -223,15 +217,12 @@ class TestSpectralDerivative(object):
                     Fref = tuple( data.get().handle.copy() for data in Fd.data )
 
                     dFd.initialize(self.__random_init)
-                    dd = DebugDumper(name=str(impl), force_overwrite=True, enable_on_op_apply=False)
-                    op.apply(dd=dd)
+                    op.apply()
                     
                     Fout  = tuple( data.get().handle.copy() for data in Fd.data )
                     dFout = tuple( data.get().handle.copy() for data in dFd.data )
                     
                     self._check_output(impl, op, Fref, dFref, Fout, dFout, idx)
-                    #import sys
-                    #sys.exit(1)
     
     @classmethod
     def _check_output(cls, impl, op, Fref, dFref, Fout, dFout, idx):
@@ -331,19 +322,18 @@ class TestSpectralDerivative(object):
         self._test(dim=3, dtype=npw.float32, polynomial=True, **kwds)
 
     def perform_tests(self):
-        #self.test_1d_trigonometric_float32(max_derivative=6)
-        #self.test_2d_trigonometric_float32(max_derivative=2+__ENABLE_LONG_TESTS__)
-        self.test_3d_trigonometric_float32(max_derivative=3+__ENABLE_LONG_TESTS__)
+        self.test_1d_trigonometric_float32(max_derivative=6)
+        self.test_2d_trigonometric_float32(max_derivative=2+__ENABLE_LONG_TESTS__)
+        self.test_3d_trigonometric_float32(max_derivative=0+__ENABLE_LONG_TESTS__)
 
-        #self.test_1d_trigonometric_float64(max_derivative=6)
-        #if __ENABLE_LONG_TESTS__:
-            #self.test_2d_trigonometric_float64(max_derivative=3)
-            #self.test_3d_trigonometric_float64(max_derivative=1)
+        self.test_1d_trigonometric_float64(max_derivative=1)
+        self.test_2d_trigonometric_float64(max_derivative=1)
         
-        #self.test_1d_polynomial_float32(max_derivative=2)
-        #self.test_2d_polynomial_float32(max_derivative=2)
-        #if __ENABLE_LONG_TESTS__:
-            #self.test3d_polynomial_float32(max_derivative=1)
+        if __ENABLE_LONG_TESTS__:
+            self.test_3d_trigonometric_float64(max_derivative=0)
+            self.test_1d_polynomial_float32(max_derivative=2)
+            self.test_2d_polynomial_float32(max_derivative=1)
+            self.test_3d_polynomial_float32(max_derivative=0)
     
 if __name__ == '__main__':
     TestSpectralDerivative.setup_class(enable_extra_tests=False, 
diff --git a/requirements.txt b/requirements.txt
index 6c38fcf73cdaee2291bee0527459be7cdaac4555..c0c1b05dc6b530a3ac74aa86eb02236dd871d45e 100644
--- a/requirements.txt
+++ b/requirements.txt
@@ -17,3 +17,4 @@ pyopencl
 pyfftw
 mpi4py
 matplotlib
+numba