From 8dace7c169b940a07a6aa3f82d59a919fe7bb2b7 Mon Sep 17 00:00:00 2001 From: Martin Bauer <martin.bauer@fau.de> Date: Mon, 18 Feb 2019 15:42:45 +0100 Subject: [PATCH] Fixed new flake8 warnings --- creationfunctions.py | 4 ++-- methods/creationfunctions.py | 4 ++-- phasefield/analytical.py | 4 ++-- phasefield/contact_angle_circle_fitting.py | 8 ++++---- phasefield/high_density_ratio_model.py | 12 ++++++------ phasefield/n_phase_boyer.py | 12 ++++++------ phasefield/phasefieldstep_direct.py | 4 ++-- 7 files changed, 24 insertions(+), 24 deletions(-) diff --git a/creationfunctions.py b/creationfunctions.py index f94cbfa7..17526add 100644 --- a/creationfunctions.py +++ b/creationfunctions.py @@ -11,7 +11,7 @@ General: - ``stencil='D2Q9'``: stencil name e.g. 'D2Q9', 'D3Q19'. See :func:`pystencils.stencils.get_stencil` for details - ``method='srt'``: name of lattice Boltzmann method. This determines the selection and relaxation pattern of - moments/cumulants, i.e. which moment/cumulant basis is chosen, and which of the basis vectors are relaxed together + moments/cumulants, i.e. which moment/cumulant basis is chosen, and which of the basis vectors are relaxed together - ``srt``: single relaxation time (:func:`lbmpy.methods.create_srt`) - ``trt``: two relaxation time, first relaxation rate is for even moments and determines the viscosity (as in SRT), the second relaxation rate is used for relaxing odd moments, and controls the bulk viscosity. @@ -51,7 +51,7 @@ General: fields. In each timestep the corresponding quantities are written to the given fields. - ``velocity_input``: symbolic field where the velocities are read from (for advection diffusion LBM) - ``density_input``: symbolic field or field access where to read density from. When passing this parameter, - ``velocity_input`` has to be passed as well + ``velocity_input`` has to be passed as well - ``kernel_type``: supported values: 'stream_pull_collide' (default), 'collide_only' diff --git a/methods/creationfunctions.py b/methods/creationfunctions.py index e9e0ae5b..859b03a4 100644 --- a/methods/creationfunctions.py +++ b/methods/creationfunctions.py @@ -315,8 +315,8 @@ def create_trt_kbc(dim, shear_relaxation_rate, higher_order_relaxation_rate, met energy_transport_tensor = list(poly_repr([a for a in moments_of_order(3, dim, True) if 3 not in a])) - explicitly_defined = set(rho + velocity + shear_tensor_off_diagonal + - shear_tensor_diagonal + energy_transport_tensor) + explicitly_defined = set(rho + velocity + shear_tensor_off_diagonal + + shear_tensor_diagonal + energy_transport_tensor) rest = list(set(poly_repr(moments_up_to_component_order(2, dim))) - explicitly_defined) assert len(rest) + len(explicitly_defined) == 3**dim diff --git a/phasefield/analytical.py b/phasefield/analytical.py index 20b7171e..ffbb4336 100644 --- a/phasefield/analytical.py +++ b/phasefield/analytical.py @@ -167,8 +167,8 @@ def free_energy_functional_n_phases(num_phases=None, surface_tensions=symmetric_ n = num_phases - 1 if k == l: assert surface_tensions(l, l) == 0 - return 3 / sp.sqrt(2) * interface_width * (surface_tensions(k, n) + - surface_tensions(l, n) - surface_tensions(k, l)) + return 3 / sp.sqrt(2) * interface_width * (surface_tensions(k, n) + + surface_tensions(l, n) - surface_tensions(k, l)) def bulk_term(i, j): return surface_tensions(i, j) / 2 * (f1(phi[i]) + f1(phi[j]) - f2(phi[i] + phi[j])) diff --git a/phasefield/contact_angle_circle_fitting.py b/phasefield/contact_angle_circle_fitting.py index 52681f6a..070193ef 100644 --- a/phasefield/contact_angle_circle_fitting.py +++ b/phasefield/contact_angle_circle_fitting.py @@ -23,12 +23,12 @@ def circle_intersections(midpoint0, midpoint1, radius0, radius1): yy = -(-b2 * k1 + b1 * k2) / (k1 - k2) return [(xx, yy)] elif np.abs(radius1 - radius0) < midpoint_distance < radius0 + radius1: - xx1 = (-b2 * k2 + x1 + k2 * y1 - np.sqrt(-b2 ** 2 + radius1 ** 2 + k2 ** 2 * radius1 ** 2 - 2 * b2 * - k2 * x1 - k2 ** 2 * x1 ** 2 + 2 * b2 * y1 + 2 * k2 * x1 * y1 - y1 ** 2)) / (1 + k2 ** 2) + xx1 = (-b2 * k2 + x1 + k2 * y1 - np.sqrt(-b2 ** 2 + radius1 ** 2 + k2 ** 2 * radius1 ** 2 - 2 * b2 + * k2 * x1 - k2 ** 2 * x1 ** 2 + 2 * b2 * y1 + 2 * k2 * x1 * y1 - y1 ** 2)) / (1 + k2 ** 2) yy1 = k2 * xx1 + b2 - xx2 = (-b2 * k2 + x1 + k2 * y1 + np.sqrt(-b2 ** 2 + radius1 ** 2 + k2 ** 2 * radius1 ** 2 - 2 * b2 * - k2 * x1 - k2 ** 2 * x1 ** 2 + 2 * b2 * y1 + 2 * k2 * x1 * y1 - y1 ** 2)) / (1 + k2 ** 2) + xx2 = (-b2 * k2 + x1 + k2 * y1 + np.sqrt(-b2 ** 2 + radius1 ** 2 + k2 ** 2 * radius1 ** 2 - 2 * b2 + * k2 * x1 - k2 ** 2 * x1 ** 2 + 2 * b2 * y1 + 2 * k2 * x1 * y1 - y1 ** 2)) / (1 + k2 ** 2) yy2 = k2 * xx2 + b2 return [(xx1, yy1), (xx2, yy2)] diff --git a/phasefield/high_density_ratio_model.py b/phasefield/high_density_ratio_model.py index 5d11f4dc..819808f1 100644 --- a/phasefield/high_density_ratio_model.py +++ b/phasefield/high_density_ratio_model.py @@ -42,10 +42,10 @@ def free_energy_high_density_ratio(eos, density, density_gas, density_liquid, c_ def f(c): return c ** 2 * (1 - c) ** 2 - f_bulk = (lambdas[0] / 2 * (psi_eos - psi_0) + - lambdas[1] / 2 * f(c_liquid_1) + - lambdas[2] / 2 * f(c_liquid_2)) - f_interface = (kappas[0] / 2 * Diff(density) ** 2 + - kappas[1] / 2 * Diff(c_liquid_1) ** 2 + - kappas[2] / 2 * Diff(c_liquid_2) ** 2) + f_bulk = (lambdas[0] / 2 * (psi_eos - psi_0) + + lambdas[1] / 2 * f(c_liquid_1) + + lambdas[2] / 2 * f(c_liquid_2)) + f_interface = (kappas[0] / 2 * Diff(density) ** 2 + + kappas[1] / 2 * Diff(c_liquid_1) ** 2 + + kappas[2] / 2 * Diff(c_liquid_2) ** 2) return f_bulk + f_interface diff --git a/phasefield/n_phase_boyer.py b/phasefield/n_phase_boyer.py index a57b98aa..bdcac888 100644 --- a/phasefield/n_phase_boyer.py +++ b/phasefield/n_phase_boyer.py @@ -123,9 +123,9 @@ def capital_f0(c, surface_tension, f=lambda c: c ** 2 * (1 - c) ** 2): def free_energy(c, epsilon, surface_tensions, stabilization_factor): alpha, _ = diffusion_coefficients(surface_tensions) - capital_f = (capital_f0(c, surface_tensions) + - correction_g(c, surface_tensions) + - stabilization_factor * stabilization_term(c, alpha)) + capital_f = (capital_f0(c, surface_tensions) + + correction_g(c, surface_tensions) + + stabilization_factor * stabilization_term(c, alpha)) def f(x): return x ** 2 * (1 - x) ** 2 @@ -200,9 +200,9 @@ def capital_gamma(sigma, i, index_tuple): assert tuple(sorted(index_tuple)) == index_tuple j, k, m = index_tuple alpha, gamma = diffusion_coefficients(sigma) - return -6 * (alpha[i, j] * (sigma[j, k] + sigma[j, m]) + - alpha[i, k] * (sigma[j, k] + sigma[k, m]) + - alpha[i, m] * (sigma[j, m] + sigma[k, m]) - gamma[i]) + return -6 * (alpha[i, j] * (sigma[j, k] + sigma[j, m]) + + alpha[i, k] * (sigma[j, k] + sigma[k, m]) + + alpha[i, m] * (sigma[j, m] + sigma[k, m]) - gamma[i]) def capital_lambda(surface_tensions, index_tuple): diff --git a/phasefield/phasefieldstep_direct.py b/phasefield/phasefieldstep_direct.py index 29f3a196..3937e37f 100644 --- a/phasefield/phasefieldstep_direct.py +++ b/phasefield/phasefieldstep_direct.py @@ -119,8 +119,8 @@ class PhaseFieldStepDirect: # Sync functions self.phi_sync = dh.synchronization_function([self.phi_field.name]) self.mu_sync = dh.synchronization_function([self.mu_field.name]) - self.pdf_sync = dh.synchronization_function([self.hydro_pdfs[0].name] + - [src.name for src, _ in self.ch_pdfs]) + self.pdf_sync = dh.synchronization_function([self.hydro_pdfs[0].name] + + [src.name for src, _ in self.ch_pdfs]) self.reset() -- GitLab